CppEphem
Public Member Functions | Static Public Member Functions | Protected Attributes | Private Member Functions | Friends | List of all members
CECoordinates Class Reference

CECoordinates class is responsible for doing all of the celestial coordinate conversions. Command line tools are also available for "on the fly" conversions.

The different coordinate systems used:

Definition at line 48 of file CECoordinates.h.

Public Member Functions

virtual CEAngle AngularSeparation (const CECoordinates &coords) const
 Get the angular separation between the coordinates represented by this object and another coordinate object. More...
 
 CECoordinates ()
 Default constructor. More...
 
 CECoordinates (const CEAngle &xcoord, const CEAngle &ycoord, const CECoordinateType &coord_type=CECoordinateType::ICRS)
 Primary constructor (NOTE: xcoord & ycoord are expected to be in radians by default. More...
 
 CECoordinates (const CECoordinates &other)
 Copy constructor. More...
 
 CECoordinates (const CECoordinateType &coord_type)
 Constructor from a coordinate type. More...
 
 CECoordinates (const std::vector< double > &xcoord, const std::vector< double > &ycoord, const CECoordinateType &coord_type=CECoordinateType::ICRS)
 Primary constructor. More...
 
CECoordinates ConvertTo (CECoordinateType output_coord_type, const CEObserver &observer, const CEDate &date=CEDate::CurrentJD())
 Convert these coordinates to another coordinate system NOTE: If this object is not OBSERVED coordinates, only JD is needed. More...
 
CECoordinates ConvertTo (CECoordinateType output_coord_type, double jd=CEDate::CurrentJD(), double longitude=0.0, double latitude=0.0, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.5)
 Convert these coordinates to another coordinate system NOTE: If neither this object or output_coord_type are OBSERVED coordinates, only JD is needed. More...
 
CECoordinates ConvertToCIRS (double jd=CEDate::CurrentJD(), double longitude=0.0, double latitude=0.0, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.5)
 Convert these coordinates to CIRS coordinates. More...
 
CECoordinates ConvertToGalactic (double jd=CEDate::CurrentJD(), double longitude=0.0, double latitude=0.0, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.5)
 Convert these coordinates to GALACTIC coordinates. More...
 
CECoordinates ConvertToICRS (double jd=CEDate::CurrentJD(), double longitude=0.0, double latitude=0.0, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.5)
 Convert these coordinates to ICRS coordinates. More...
 
CECoordinates ConvertToObserved (double jd=CEDate::CurrentJD(), double longitude=0.0, double latitude=0.0, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.5)
 Convert these coordinates to observed coordinates. More...
 
CECoordinateType GetCoordSystem (void) const
 Return coordinate system. More...
 
virtual CECoordinates GetObservedCoords (const CEDate &date, const CEObserver &observer) const
 Return the observed coordinates using an observer object (CEObserver) More...
 
virtual CECoordinates GetObservedCoords (const double &julian_date, const double &longitude, const double &latitude, const double &elevation_m=0.0, const double &pressure_hPa=-1.0, const double &temperature_celsius=-1000, const double &relative_humidity=0.0, const double &dut1=0.0, const double &xp=0.0, const double &yp=0.0, const double &wavelength_um=0.5) const
 Return the local sky coordinates of this object as a CECoordinates object. More...
 
CECoordinatesoperator= (const CECoordinates &other)
 Overloaded '=' (assignment) operator. More...
 
std::string print (void) const
 Generate a message string that specifies the information about this coordinate. More...
 
virtual void SetCoordinates (const CEAngle &xcoord, const CEAngle &ycoord, const CECoordinateType &coord_type=CECoordinateType::ICRS)
 Set the coordinates of this object. More...
 
virtual void SetCoordinates (const CECoordinates &coords)
 Set the coordinates from another CECoordinates object. More...
 
virtual CEAngle XCoord (const double &jd=CppEphem::julian_date_J2000()) const
 Return x coordinate at given Julian date. More...
 
virtual double XCoordinate_Deg (double jd=CppEphem::julian_date_J2000()) const
 Returns x coordinate at given julian date in degrees. More...
 
virtual double XCoordinate_Rad (double jd=CppEphem::julian_date_J2000()) const
 Return x coordinate at given Julian date in radians. More...
 
virtual CEAngle YCoord (const double &jd=CppEphem::julian_date_J2000()) const
 Return y coordinate at given Julian date. More...
 
virtual double YCoordinate_Deg (double jd=CppEphem::julian_date_J2000()) const
 Returns y coordinate at given Julian date in degrees. More...
 
virtual double YCoordinate_Rad (double jd=CppEphem::julian_date_J2000()) const
 Returns y coordinate at given Julian date in radians. More...
 
virtual ~CECoordinates ()
 Destructor. More...
 

Static Public Member Functions

static CEAngle AngularSeparation (const CEAngle &xcoord_first, const CEAngle &ycoord_first, const CEAngle &xcoord_second, const CEAngle &ycoord_second)
 Get the angular separation between two sets of coordinates. More...
 
static CEAngle AngularSeparation (const CECoordinates &coords1, const CECoordinates &coords2)
 Get the angular separation between two coordinate objects. More...
 
static void CIRS2Galactic (double ra, double dec, double *glon, double *glat, const CEDate &date=CEDate(), const CEAngleType &angle_type=CEAngleType::RADIANS)
 CIRS -> Galactic coordinate conversion. More...
 
static void CIRS2ICRS (double input_ra, double input_dec, double *return_ra, double *return_dec, const CEDate &date=CEDate(), const CEAngleType &angle_type=CEAngleType::RADIANS)
 CIRS -> ICRS coordinate conversion. More...
 
static int CIRS2Observed (double ra, double dec, double *az, double *zen, const CEDate &date, const CEObserver &observer, const CEAngleType &angle_type=CEAngleType::RADIANS, double wavelength_um=0.5, double *observed_ra=nullptr, double *observed_dec=nullptr, double *hour_angle=nullptr)
 CIRS -> Observed (or observer specific) coordinate conversion This function takes in verious observation parameters The integer returned is a status code with the following meanings: +1 = dubious year (too far into the past/future to be trusted) 0 = OK status -1 = unacceptable date. More...
 
static int CIRS2Observed (double ra, double dec, double *az, double *zen, double julian_date, double longitude, double latitude, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.5, double *observed_ra=nullptr, double *observed_dec=nullptr, double *hour_angle=nullptr)
 Raw method for converting CIRS -> Observed (observer specific) coordinates (uses the SOFA 'iauAtio13' function) Note: All angles are expected to be in radians. More...
 
static double DMSToAngle (const std::vector< double > &angle, const CEAngleType &return_type=CEAngleType::DEGREES)
 Convert a given angle vector from {degrees, minutes, seconds} to an angle. More...
 
static void Galactic2CIRS (double glon, double glat, double *ra, double *dec, const CEDate &date=CEDate(), const CEAngleType &angle_type=CEAngleType::RADIANS)
 Galactic -> CIRS coordinate conversion. More...
 
static void Galactic2ICRS (double glon, double glat, double *ra, double *dec, const CEAngleType &angle_type=CEAngleType::RADIANS)
 Galactic -> ICRS coordinate conversion. More...
 
static int Galactic2Observed (double glon, double glat, double *az, double *zen, const CEDate &date, const CEObserver &observer, const CEAngleType &angle_type=CEAngleType::RADIANS, double wavelength_um=0.5, double *observed_glon=nullptr, double *observed_glat=nullptr, double *hour_angle=nullptr)
 Galactic -> Observed (i.e. More...
 
static int Galactic2Observed (double glon, double glat, double *az, double *zen, double julian_date, double longitude, double latitude, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.50, double *observed_glon=nullptr, double *observed_glat=nullptr, double *hour_angle=nullptr)
 Raw method for converting Galactic -> Observed (observer specific) coordinates. More...
 
static std::vector< double > GetDMS (const double &angle, const CEAngleType &angle_type=CEAngleType::DEGREES)
 Convert a given angle into degrees, arcminutes, arcseconds. More...
 
static std::vector< double > GetHMS (const double &angle, const CEAngleType &angle_type=CEAngleType::DEGREES)
 Convert a given angle into hours, minutes, seconds. More...
 
static double HMSToAngle (const std::vector< double > &angle, const CEAngleType &return_type=CEAngleType::DEGREES)
 Convert from {hours, minutes, seconds} to an angle. More...
 
static void ICRS2CIRS (double input_ra, double input_dec, double *return_ra, double *return_dec, const CEDate &date=CEDate(), const CEAngleType &angle_type=CEAngleType::RADIANS)
 ICRS -> CIRS coordinate conversion. More...
 
static void ICRS2Galactic (double ra, double dec, double *glon, double *glat, const CEAngleType &angle_type=CEAngleType::RADIANS)
 ICRS -> Galactic coordinate conversion (uses the SOFA 'iauIcrs2g' function) More...
 
static int ICRS2Observed (double ra, double dec, double *az, double *zen, const CEDate &date, const CEObserver &observer, const CEAngleType &angle_type=CEAngleType::RADIANS, double wavelength_um=0.5, double *observed_ra=nullptr, double *observed_dec=nullptr, double *hour_angle=nullptr)
 ICRS -> Observed coordinate conversion. More...
 
static int ICRS2Observed (double ra, double dec, double *az, double *zen, double julian_date, double longitude, double latitude, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.5, double *observed_ra=nullptr, double *observed_dec=nullptr, double *hour_angle=nullptr)
 Raw method for converting CIRS -> Observed (observer specific) coordinates. More...
 
static int Observed2CIRS (double az, double zen, double *ra, double *dec, const CEDate &date, const CEObserver &observer, const CEAngleType &angle_type=CEAngleType::RADIANS)
 Convert Observed -> CIRS coordinates. More...
 
static int Observed2CIRS (double az, double zen, double *ra, double *dec, double julian_date, double longitude, double latitude, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.5)
 Raw method for converting Observed (observer specific) -> CIRS coordinates (uses the SOFA 'iauAtoi13' function) Note: All angles are expected to be in radians. More...
 
static int Observed2Galactic (double az, double zen, double *glon, double *glat, const CEDate &date, const CEObserver &observer, const CEAngleType &angle_type=CEAngleType::RADIANS)
 Convert Observed -> Galactic coordinates. More...
 
static int Observed2Galactic (double az, double zen, double *glon, double *glat, double julian_date, double longitude, double latitude, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.50)
 Raw method for converting Observed (observer specific) -> Galactic coordinates Note: All angles are expected to be in radians. More...
 
static int Observed2ICRS (double az, double zen, double *ra, double *dec, const CEDate &date, const CEObserver &observer, const CEAngleType &angle_type=CEAngleType::RADIANS)
 Convert Observed -> ICRS coordinates. More...
 
static int Observed2ICRS (double az, double zen, double *ra, double *dec, double julian_date, double longitude, double latitude, double elevation_m=0.0, double pressure_hPa=-1.0, double temperature_celsius=-1000, double relative_humidity=0.0, double dut1=0.0, double xp=0.0, double yp=0.0, double wavelength_um=0.5)
 Raw method for converting Observed (observer specific) -> ICRS coordinates Note: All angles are expected to be in radians. More...
 

Protected Attributes

CECoordinateType coord_type_
 
CEAngle xcoord_
 
CEAngle ycoord_
 

Private Member Functions

void copy_members (const CECoordinates &other)
 Copy data members from another CECoordinates object. More...
 
void free_members (void)
 Cleanup data members that need to be freed or cleared. More...
 
void init_members (void)
 Set initial values and allocate memory for data members. More...
 

Friends

bool operator!= (const CECoordinates &lhs, const CECoordinates &rhs)
 Compare two coordinate objects. More...
 
bool operator== (const CECoordinates &lhs, const CECoordinates &rhs)
 Compare two coordinate objects. More...
 

#include <CECoordinates.h>

Collaboration diagram for CECoordinates:
Collaboration graph
[legend]

Constructor & Destructor Documentation

◆ CECoordinates() [1/5]

CECoordinates::CECoordinates ( )

Default constructor.

Definition at line 38 of file CECoordinates.cpp.

◆ CECoordinates() [2/5]

CECoordinates::CECoordinates ( const CEAngle xcoord,
const CEAngle ycoord,
const CECoordinateType coord_type = CECoordinateType::ICRS 
)

Primary constructor (NOTE: xcoord & ycoord are expected to be in radians by default.

Parameters
[in]xcoordX-Coordinate (radians)
[in]ycoordY-Coordinate (radians)
[in]coord_typeCoordinate type (see CECoordinateType)
[in]angle_typeAngle type (either DEGREES or RADIANS)

Definition at line 52 of file CECoordinates.cpp.

◆ CECoordinates() [3/5]

CECoordinates::CECoordinates ( const std::vector< double > &  xcoord,
const std::vector< double > &  ycoord,
const CECoordinateType coord_type = CECoordinateType::ICRS 
)

Primary constructor.

Parameters
[in]xcoordX-Coordinate {hours,minutes,seconds}
[in]ycoordY-Coordinate {degrees, arcmin, arcsec}
[in]coord_typeCoordinate type (see CECoordinateType)
[in]angle_typeAngle type (either DEGREES or RADIANS)

Definition at line 69 of file CECoordinates.cpp.

◆ CECoordinates() [4/5]

CECoordinates::CECoordinates ( const CECoordinateType coord_type)

Constructor from a coordinate type.

Parameters
[in]coord_typeCoordinate type (see CECoordinateType)

Definition at line 91 of file CECoordinates.cpp.

◆ CECoordinates() [5/5]

CECoordinates::CECoordinates ( const CECoordinates other)

Copy constructor.

Parameters
[in]otherCoordinates object to be copied

Definition at line 102 of file CECoordinates.cpp.

◆ ~CECoordinates()

CECoordinates::~CECoordinates ( )
virtual

Destructor.

Definition at line 112 of file CECoordinates.cpp.

Member Function Documentation

◆ AngularSeparation() [1/3]

CEAngle CECoordinates::AngularSeparation ( const CEAngle xcoord_first,
const CEAngle ycoord_first,
const CEAngle xcoord_second,
const CEAngle ycoord_second 
)
static

Get the angular separation between two sets of coordinates.

Method utilizes the SOFA 'iauSeps' algorithm. NOTE: The coordinates are both expected to be in the same coordinate system!

Parameters
[in]xcoord_firstX-value for first set of coordinates
[in]ycoord_firstY-value for first set of coordinates
[in]xcoord_secondX-value for second set of coordiantes
[in]ycoord_secondY-value for second set of coordinates
[in]return_angle_typeSpecify whether input angles are DEGREES or RADIANS. (output angle will be in the same format)
Returns
Angular separation between two coordinates

Note that the x-coordinates are expected in the range [0, 2pi] and the y-coordinates are expected in the range [-pi, pi]. Because of this, you need to pass:

  • ICRS: RA, Dec
  • CIRS: RA, Dec
  • GALACTIC: G.Lon, G.Lat
  • OBSERVED: Az, Alt (by default the y-coordinate is zenith)

Definition at line 1235 of file CECoordinates.cpp.

◆ AngularSeparation() [2/3]

CEAngle CECoordinates::AngularSeparation ( const CECoordinates coords) const
virtual

Get the angular separation between the coordinates represented by this object and another coordinate object.

NOTE: The coordinates are both expected to be in the same coordinate system! If they are in different coordinate systems, use "ConvertTo()" first.

Parameters
[in]coordsAnother set of coordinates
Returns
Angular separation between these coordinates and 'coords'

Definition at line 1169 of file CECoordinates.cpp.

◆ AngularSeparation() [3/3]

CEAngle CECoordinates::AngularSeparation ( const CECoordinates coords1,
const CECoordinates coords2 
)
static

Get the angular separation between two coordinate objects.

NOTE: The coordinates are both expected to be in the same coordinate system! If they are in different coordinate systems, use "ConvertTo()" first.

Parameters
[in]coords1First set of coordinates
[in]coords2Second set of coordinates
[in]return_angle_typeSpecify whether to return angle as DEGREES or RADIANS
Returns
Angular separation between two coordiantes

Note that the x-coordinates are expected in the range [0, 2pi] and the y-coordinates are expected in the range [-pi, pi]. Because of this, OBSERVED coordinates first convert the zenith angle to altitude

Definition at line 1189 of file CECoordinates.cpp.

◆ CIRS2Galactic()

void CECoordinates::CIRS2Galactic ( double  input_ra,
double  input_dec,
double *  glon,
double *  glat,
const CEDate date = CEDate(),
const CEAngleType angle_type = CEAngleType::RADIANS 
)
static

CIRS -> Galactic coordinate conversion.

Parameters
[in]input_raCIRS right ascension
[in]input_decCIRS declination
[out]glonGalactic longitude
[out]glatGalactic latitude
[in]dateDate information
[in]angle_typeAngle format (DEGREES or RADIANS)

Definition at line 181 of file CECoordinates.cpp.

◆ CIRS2ICRS()

void CECoordinates::CIRS2ICRS ( double  input_ra,
double  input_dec,
double *  return_ra,
double *  return_dec,
const CEDate date = CEDate(),
const CEAngleType angle_type = CEAngleType::RADIANS 
)
static

CIRS -> ICRS coordinate conversion.

(uses SOFA 'iauAtic13' function)

Parameters
[in]input_raCIRS right ascension
[in]input_decCIRS declination
[out]return_raICRS right ascension (returned)
[out]return_decICRS declinaton (returned)
[in]dateDate information
[in]angle_typeInput/output angle type (DEGREES or RADIANS)

Definition at line 144 of file CECoordinates.cpp.

◆ CIRS2Observed() [1/2]

int CECoordinates::CIRS2Observed ( double  ra,
double  dec,
double *  az,
double *  zen,
const CEDate date,
const CEObserver observer,
const CEAngleType angle_type = CEAngleType::RADIANS,
double  wavelength = 0.5,
double *  observed_ra = nullptr,
double *  observed_dec = nullptr,
double *  hour_angle = nullptr 
)
static

CIRS -> Observed (or observer specific) coordinate conversion This function takes in verious observation parameters The integer returned is a status code with the following meanings: +1 = dubious year (too far into the past/future to be trusted) 0 = OK status -1 = unacceptable date.

Parameters
[in]raRight ascension in CIRS coordinates
[in]decDeclination in CIRS coordinates
[out]azAzimuth (returned)
[out]zenZenith angle (returned)
[in]observerObserver information
[in]angle_typeAngle type (see CEAngleType)
[in]wavelengthWavelength of the light being observed (micrometers)
[out]observed_raObserved right ascension (returned)
[out]observed_decObserved declination (returned)
[out]hour_angleHour angle of object being observed (returned)

Definition at line 224 of file CECoordinates.cpp.

◆ CIRS2Observed() [2/2]

int CECoordinates::CIRS2Observed ( double  ra,
double  dec,
double *  az,
double *  zen,
double  julian_date,
double  longitude,
double  latitude,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.5,
double *  observed_ra = nullptr,
double *  observed_dec = nullptr,
double *  hour_angle = nullptr 
)
static

Raw method for converting CIRS -> Observed (observer specific) coordinates (uses the SOFA 'iauAtio13' function) Note: All angles are expected to be in radians.

Parameters
[in]raCIRS right ascension (radians)
[in]decCIRS declination (radians)
[out]azObserved azimuth angle (radians, returned)
[out]zenObserved zenith angle (radians, returned)
[in]julian_dateJulian date for conversion
[in]longitudeObserver geographic longitude (radians)
[in]latitudeObserver geographic latitude (radians)
[in]elevation_mObserver elevation (meters)
[in]pressure_hPaAtmospheric pressure (HPa)
[in]temperature_celsiusTemperature (degrees Celsius)
[in]relative_humidityRelative humidity (0.0 - 1.0)
[in]dut1UT1 - UTC
[in]xp"x" polar motion
[in]yp"y" polar motion
[in]wavelength_umWavelength (micrometers)
[out]observed_raApparent right ascension (returned)
[out]observed_decApparent declination (returned)
[out]hour_angleHour angle

Definition at line 712 of file CECoordinates.cpp.

◆ ConvertTo() [1/2]

CECoordinates CECoordinates::ConvertTo ( CECoordinateType  output_coord_type,
const CEObserver observer,
const CEDate date = CEDate::CurrentJD() 
)

Convert these coordinates to another coordinate system NOTE: If this object is not OBSERVED coordinates, only JD is needed.

NOTE: If 'observer' is not nulltr then 'jd' will be ignored and the date will instead be derived from the observers date.

Parameters
[in]output_coord_typeOutput coordinate type (see CECoordinateType)
[in]dateJulian date for conversion
[in]observerIf these coordinates are OBSERVED, then observer represents the observer for these coordinates. Otherwise they represent the observer to convert the coordinates to.
Returns
Coordinates object that represents coordinates we're converting to

Definition at line 1261 of file CECoordinates.cpp.

◆ ConvertTo() [2/2]

CECoordinates CECoordinates::ConvertTo ( CECoordinateType  output_coord_type,
double  jd = CEDate::CurrentJD(),
double  longitude = 0.0,
double  latitude = 0.0,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.5 
)

Convert these coordinates to another coordinate system NOTE: If neither this object or output_coord_type are OBSERVED coordinates, only JD is needed.

Parameters
[in]output_coord_typeOutput coordinate type (see CECoordinateType)
[in]jdJulian date for conversion
[in]longitudeObserver longitude (radians, east-positive)
[in]latitudeObserver latitude (radians)
[in]elevation_mElevation (meters above sea level)
[in]pressure_hPaAtmospheric pressure (hPa)
[in]temperature_celsiusAtmospheric temperature (degrees celsius)
[in]relative_humidityRelative humidity
[in]dut1DUT1 value representing UTC-UT1
[in]xpx-polar motion
[in]ypy-polar motion
[in]wavelength_umwavelength (micrometers)
Returns
CECoordinates object representing CIRS right ascension, declination

Definition at line 1300 of file CECoordinates.cpp.

◆ ConvertToCIRS()

CECoordinates CECoordinates::ConvertToCIRS ( double  jd = CEDate::CurrentJD(),
double  longitude = 0.0,
double  latitude = 0.0,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.5 
)

Convert these coordinates to CIRS coordinates.

NOTE: If this object is not OBSERVED coordinates, only JD is needed.

Parameters
[in]jdJulian date for conversion
[in]longitudeObserver longitude (radians, east-positive)
[in]latitudeObserver latitude (radians)
[in]elevation_mElevation (meters above sea level)
[in]pressure_hPaAtmospheric pressure (hPa)
[in]temperature_celsiusAtmospheric temperature (degrees celsius)
[in]relative_humidityRelative humidity
[in]dut1DUT1 value representing UTC-UT1
[in]xpx-polar motion
[in]ypy-polar motion
[in]wavelength_umwavelength (micrometers)
Returns
CECoordinates object representing CIRS right ascension, declination

Definition at line 1358 of file CECoordinates.cpp.

◆ ConvertToGalactic()

CECoordinates CECoordinates::ConvertToGalactic ( double  jd = CEDate::CurrentJD(),
double  longitude = 0.0,
double  latitude = 0.0,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.5 
)

Convert these coordinates to GALACTIC coordinates.

NOTE: If this object is not OBSERVED coordinates, only JD is needed. NOTE: If this object is ICRS coordinates, JD is not necessary

Parameters
[in]jdJulian date for conversion
[in]longitudeObserver longitude (radians, east-positive)
[in]latitudeObserver latitude (radians)
[in]elevation_mElevation (meters above sea level)
[in]pressure_hPaAtmospheric pressure (hPa)
[in]temperature_celsiusAtmospheric temperature (degrees celsius)
[in]relative_humidityRelative humidity
[in]dut1DUT1 value representing UTC-UT1
[in]xpx-polar motion
[in]ypy-polar motion
[in]wavelength_umwavelength (micrometers)
Returns
CECoordinates object representing galactic longitude,latitude

Definition at line 1471 of file CECoordinates.cpp.

◆ ConvertToICRS()

CECoordinates CECoordinates::ConvertToICRS ( double  jd = CEDate::CurrentJD(),
double  longitude = 0.0,
double  latitude = 0.0,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.5 
)

Convert these coordinates to ICRS coordinates.

NOTE: If this object is not OBSERVED coordinates, only JD is needed. NOTE: If this object is GALACTIC coordinates, JD is not necessary

Parameters
[in]jdJulian date for conversion
[in]longitudeObserver longitude (radians, east-positive)
[in]latitudeObserver latitude (radians)
[in]elevation_mElevation (meters above sea level)
[in]pressure_hPaAtmospheric pressure (hPa)
[in]temperature_celsiusAtmospheric temperature (degrees celsius)
[in]relative_humidityRelative humidity
[in]dut1DUT1 value representing UTC-UT1
[in]xpx-polar motion
[in]ypy-polar motion
[in]wavelength_umwavelength (micrometers)
Returns
CECoordinates object representing ICRS right ascension, declination

Definition at line 1418 of file CECoordinates.cpp.

◆ ConvertToObserved()

CECoordinates CECoordinates::ConvertToObserved ( double  jd = CEDate::CurrentJD(),
double  longitude = 0.0,
double  latitude = 0.0,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.5 
)

Convert these coordinates to observed coordinates.

Note: For accurate positions you MUST supply at least jd, longitude, and latitude

Parameters
[in]jdJulian date for conversion
[in]longitudeObserver longitude (radians, east-positive)
[in]latitudeObserver latitude (radians)
[in]elevation_mElevation (meters above sea level)
[in]pressure_hPaAtmospheric pressure (hPa)
[in]temperature_celsiusAtmospheric temperature (degrees celsius)
[in]relative_humidityRelative humidity
[in]dut1DUT1 value representing UTC-UT1
[in]xpx-polar motion
[in]ypy-polar motion
[in]wavelength_umwavelength (micrometers)
Returns
CECoordinates object representing the observed altitude, zenith angle of these coordinates.

Definition at line 1522 of file CECoordinates.cpp.

◆ copy_members()

void CECoordinates::copy_members ( const CECoordinates other)
private

Copy data members from another CECoordinates object.

Parameters
[in]otherAnother coordinates objec to copy

Definition at line 1719 of file CECoordinates.cpp.

◆ DMSToAngle()

double CECoordinates::DMSToAngle ( const std::vector< double > &  angle,
const CEAngleType return_type = CEAngleType::DEGREES 
)
static

Convert a given angle vector from {degrees, minutes, seconds} to an angle.

Parameters
[in]angleWhat is the angle value
[in]return_typeSpecifies angle type for returned value
Returns
Angle

The supplied angle value should be of length 3 with the indices having the following values -[0] = Degrees -[1] = Arcminutes -[2] = Arcseconds -[3] = Arcsec fraction (can be omitted if [2] is the decimal value)

Definition at line 1662 of file CECoordinates.cpp.

◆ free_members()

void CECoordinates::free_members ( void  )
private

Cleanup data members that need to be freed or cleared.

Definition at line 1730 of file CECoordinates.cpp.

◆ Galactic2CIRS()

void CECoordinates::Galactic2CIRS ( double  glon,
double  glat,
double *  ra,
double *  dec,
const CEDate date = CEDate(),
const CEAngleType angle_type = CEAngleType::RADIANS 
)
static

Galactic -> CIRS coordinate conversion.

Parameters
[in]glonGalactic longitude
[in]glatGalactic latitude
[out]raCIRS right ascension
[out]decCIRS declination
[in]dateDate information
[in]angle_typeAngle type (RADIANS or DEGREES)

Definition at line 441 of file CECoordinates.cpp.

◆ Galactic2ICRS()

void CECoordinates::Galactic2ICRS ( double  glon,
double  glat,
double *  ra,
double *  dec,
const CEAngleType angle_type = CEAngleType::RADIANS 
)
static

Galactic -> ICRS coordinate conversion.

Parameters
[in]glonGalactic longitude
[in]glatGalactic latitude
[out]raICRS right ascension (returned)
[out]decICRS declinaton (returned)
[in]angle_typeAngle type (DEGREES or RADIANS)

Definition at line 474 of file CECoordinates.cpp.

◆ Galactic2Observed() [1/2]

int CECoordinates::Galactic2Observed ( double  glon,
double  glat,
double *  az,
double *  zen,
const CEDate date,
const CEObserver observer,
const CEAngleType angle_type = CEAngleType::RADIANS,
double  wavelength = 0.5,
double *  observed_glon = nullptr,
double *  observed_glat = nullptr,
double *  hour_angle = nullptr 
)
static

Galactic -> Observed (i.e.

observer specific) coordinate conversion. For the raw version of this method see CECoordinates::Galactic2Observed().

Parameters
[in]glonGalactic longitude
[in]glatGalactic latitude
[out]azAzimuth angle (returned)
[out]zenZenith angle (returned)
[in]observerObserver information
[in]wavelengthWavelength
[out]observed_glonObserved galactic longitude (returned)
[out]observed_glatObserved galactic latitude (returned)
[out]hour_angleObserved hour angle of object

Definition at line 508 of file CECoordinates.cpp.

◆ Galactic2Observed() [2/2]

int CECoordinates::Galactic2Observed ( double  glon,
double  glat,
double *  az,
double *  zen,
double  julian_date,
double  longitude,
double  latitude,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength = 0.50,
double *  observed_glon = nullptr,
double *  observed_glat = nullptr,
double *  hour_angle = nullptr 
)
static

Raw method for converting Galactic -> Observed (observer specific) coordinates.

Note: All angles are expected to be in radians.

Parameters
[in]glonGalactic longitude (radians)
[in]glatGalactic latitude (radians)
[out]azObserved azimuth angle (radians, returned)
[out]zenObserved zenith angle (radians, returned)
[in]julian_dateJulian date for conversion
[in]longitudeObserver geographic longitude (radians)
[in]latitudeObserver geographic latitude (radians)
[in]elevation_mObserver elevation (meters)
[in]pressure_hPaAtmospheric pressure (HPa)
[in]temperature_celsiusTemperature (degrees Celsius)
[in]relative_humidityRelative humidity (0.0 - 1.0)
[in]dut1UTC - UT1
[in]xp"x" polar motion
[in]yp"y" polar motion
[in]wavelengthWavelength
[out]observed_glonApparent galactic longitude (returned)
[out]observed_glatApparent galactic latitude (returned)
[out]hour_angleHour angle

Definition at line 965 of file CECoordinates.cpp.

◆ GetCoordSystem()

CECoordinateType CECoordinates::GetCoordSystem ( void  ) const
inline

Return coordinate system.

Returns
Coordinate type of this object

Definition at line 486 of file CECoordinates.h.

◆ GetDMS()

std::vector< double > CECoordinates::GetDMS ( const double &  angle,
const CEAngleType angle_type = CEAngleType::DEGREES 
)
static

Convert a given angle into degrees, arcminutes, arcseconds.

Parameters
[in]angleWhat is the angle value
[in]angle_typeSpecifies what type of angle
Returns
Vector containing the following values -[0] = Degrees -[1] = Arcminutes -[2] = Arcseconds -[3] = Arcsec fraction

Definition at line 1594 of file CECoordinates.cpp.

◆ GetHMS()

std::vector< double > CECoordinates::GetHMS ( const double &  angle,
const CEAngleType angle_type = CEAngleType::DEGREES 
)
static

Convert a given angle into hours, minutes, seconds.

This method is almost exclusively only useful for right ascension

Parameters
[in]angleWhat is the angle value
[in]angle_typeSpecifies what type of angle
Returns
Vector containing the following values -[0] = Hours -[1] = Minutes -[2] = Seconds -[3] = Fractions of a second

Definition at line 1613 of file CECoordinates.cpp.

◆ GetObservedCoords() [1/2]

CECoordinates CECoordinates::GetObservedCoords ( const CEDate date,
const CEObserver observer 
) const
virtual

Return the observed coordinates using an observer object (CEObserver)

Parameters
[in]dateJulian date of the observation
[in]observerObserver information
[in]wavelength_umWavelength being observed (micrometers)
Returns
These coordinates converted into the observed coordinates of 'observer'

Definition at line 1143 of file CECoordinates.cpp.

◆ GetObservedCoords() [2/2]

CECoordinates CECoordinates::GetObservedCoords ( const double &  julian_date,
const double &  longitude,
const double &  latitude,
const double &  elevation_m = 0.0,
const double &  pressure_hPa = -1.0,
const double &  temperature_celsius = -1000,
const double &  relative_humidity = 0.0,
const double &  dut1 = 0.0,
const double &  xp = 0.0,
const double &  yp = 0.0,
const double &  wavelength = 0.5 
) const
virtual

Return the local sky coordinates of this object as a CECoordinates object.

Parameters
[in]julian_dateJulian date of the observation
[in]longitudeObserver longitude (radians)
[in]latitudeObserver latitude (radians)
[in]elevation_mObserver elevation (meters)
[in]pressure_hPaObserver atmospheric pressure (hPa)
[in]temerature_celsiusTemperature (degrees Celsius)
[in]relative_humidityRelative humidity
[in]dut1'UTC-UT1'
[in]xpx-polar motion
[in]ypy-polar motion
[in]wavelength_umWavelength being observed (micrometers)
Returns
These coordinates converted into the observed coordinates of the observer specified

Definition at line 1087 of file CECoordinates.cpp.

◆ HMSToAngle()

double CECoordinates::HMSToAngle ( const std::vector< double > &  angle,
const CEAngleType return_type = CEAngleType::DEGREES 
)
static

Convert from {hours, minutes, seconds} to an angle.

Parameters
[in]angleWhat is the angle value
[in]return_typeSpecifies angle type for returned value
Returns
Angle

The supplied angle value should be of length 3 with the indices having the following values -[0] = Hours -[1] = Minutes -[2] = Seconds -[3] = Fraction of a second (not absolutely necessary)

Definition at line 1636 of file CECoordinates.cpp.

◆ ICRS2CIRS()

void CECoordinates::ICRS2CIRS ( double  input_ra,
double  input_dec,
double *  return_ra,
double *  return_dec,
const CEDate date = CEDate(),
const CEAngleType angle_type = CEAngleType::RADIANS 
)
static

ICRS -> CIRS coordinate conversion.

Uses the SOFA function 'iauAtci13'

Parameters
[in]input_raRight ascension to be converted
[in]input_decDeclination to be converted
[out]return_raCIRS Right ascension (returned)
[out]return_decCIRS Declination (returned)
[in]dateDate object
[in]angle_typeAngle type (either DEGREES or RADIANS)

Definition at line 287 of file CECoordinates.cpp.

◆ ICRS2Galactic()

void CECoordinates::ICRS2Galactic ( double  input_ra,
double  input_dec,
double *  glon,
double *  glat,
const CEAngleType angle_type = CEAngleType::RADIANS 
)
static

ICRS -> Galactic coordinate conversion (uses the SOFA 'iauIcrs2g' function)

Parameters
[in]input_raICRS Right ascension
[in]input_decICRS Declination
[out]glonGalactic longitude
[out]glatGalactic latitude
[in]angle_typeAngle type

Definition at line 336 of file CECoordinates.cpp.

◆ ICRS2Observed() [1/2]

int CECoordinates::ICRS2Observed ( double  ra,
double  dec,
double *  az,
double *  zen,
const CEDate date,
const CEObserver observer,
const CEAngleType angle_type = CEAngleType::RADIANS,
double  wavelength = 0.5,
double *  observed_ra = nullptr,
double *  observed_dec = nullptr,
double *  hour_angle = nullptr 
)
static

ICRS -> Observed coordinate conversion.

The integer returned is a status code with the following meanings: +1 = dubious year (too far into the past/future to be trusted) 0 = OK status -1 = unacceptable date

Parameters
[in]raICRS right ascension
[in]decICRS declination
[out]azAzimuth
[out]zenZenith
[in]observerObserver information
[in]angle_typeAngle type
[out]observed_raApparent ICRS Right Ascension
[out]observed_decApparent ICRS Declination
[out]hour_angleObserved hour angle of object

Definition at line 373 of file CECoordinates.cpp.

◆ ICRS2Observed() [2/2]

int CECoordinates::ICRS2Observed ( double  ra,
double  dec,
double *  az,
double *  zen,
double  julian_date,
double  longitude,
double  latitude,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.5,
double *  observed_ra = nullptr,
double *  observed_dec = nullptr,
double *  hour_angle = nullptr 
)
static

Raw method for converting CIRS -> Observed (observer specific) coordinates.

Note: All angles are expected to be in radians.

Parameters
[in]raCIRS right ascension (radians)
[in]decCIRS declination (radians)
[out]azObserved azimuth angle (radians, returned)
[out]zenObserved zenith angle (radians, returned)
[in]julian_dateJulian date for conversion
[in]longitudeObserver geographic longitude (radians)
[in]latitudeObserver geographic latitude (radians)
[in]elevation_mObserver elevation (meters)
[in]pressure_hPaAtmospheric pressure (HPa)
[in]temperature_celsiusTemperature (degrees Celsius)
[in]relative_humidityRelative humidity (0.0 - 1.0)
[in]dut1UTC - UT1
[in]xp"x" polar motion
[in]yp"y" polar motion
[in]wavelengthWavelength (micrometers)
[out]observed_raApparent right ascension (returned)
[out]observed_decApparent declination (returned)
[out]hour_angleHour angle

Definition at line 838 of file CECoordinates.cpp.

◆ init_members()

void CECoordinates::init_members ( void  )
private

Set initial values and allocate memory for data members.

Definition at line 1739 of file CECoordinates.cpp.

◆ Observed2CIRS() [1/2]

int CECoordinates::Observed2CIRS ( double  az,
double  zen,
double *  ra,
double *  dec,
const CEDate date,
const CEObserver observer,
const CEAngleType angle_type = CEAngleType::RADIANS 
)
static

Convert Observed -> CIRS coordinates.

Parameters
[in]azAzimuth of the coordinates
[in]zenZenith angle of the coordinates
[out]raCIRS right ascension (returned)
[out]decCIRS declination (returned)
[in]observerCEObserver object describing observer
[in]angle_typeAngle type of input/output coordinates

Definition at line 566 of file CECoordinates.cpp.

◆ Observed2CIRS() [2/2]

int CECoordinates::Observed2CIRS ( double  az,
double  zen,
double *  ra,
double *  dec,
double  julian_date,
double  longitude,
double  latitude,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.5 
)
static

Raw method for converting Observed (observer specific) -> CIRS coordinates (uses the SOFA 'iauAtoi13' function) Note: All angles are expected to be in radians.

Parameters
[in]azObserved azimuth angle
[in]zenObserved zenith angle
[out]raCIRS right ascension (returned)
[out]decCIRS declination (returned)
[in]julian_dateJulian date for conversion
[in]longitudeObserver geographic longitude
[in]latitudeObserver geographic latitude
[in]elevation_mObserver elevation (meters)
[in]pressure_hPaAtmospheric pressure (HPa)
[in]temperature_celsiusTemperature (degrees Celsius)
[in]relative_humidityRelative humidity (0.0 - 1.0)
[in]dut1UTC - UT1
[in]xp"x" polar motion
[in]yp"y" polar motion
[in]wavelength_umWavelength (micrometers)

Definition at line 787 of file CECoordinates.cpp.

◆ Observed2Galactic() [1/2]

int CECoordinates::Observed2Galactic ( double  az,
double  zen,
double *  glon,
double *  glat,
const CEDate date,
const CEObserver observer,
const CEAngleType angle_type = CEAngleType::RADIANS 
)
static

Convert Observed -> Galactic coordinates.

Parameters
[in]azAzimuth of the coordinates
[in]zenZenith angle of the coordinates
[out]glonGalactic longitude (returned)
[out]glatGalactic latitude (returned)
[in]observerCEObserver object describing observer
[in]angle_typeAngle type of input/output coordinates

Definition at line 653 of file CECoordinates.cpp.

◆ Observed2Galactic() [2/2]

int CECoordinates::Observed2Galactic ( double  az,
double  zen,
double *  glon,
double *  glat,
double  julian_date,
double  longitude,
double  latitude,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.50 
)
static

Raw method for converting Observed (observer specific) -> Galactic coordinates Note: All angles are expected to be in radians.

Parameters
[in]azObserved azimuth angle (radians)
[in]zenObserved zenith angle (radians)
[out]glonGalactic longitude (radians, returned)
[out]glatGalactic latitude (radians, returned)
[in]julian_dateJulian date for conversion
[in]longitudeObserver geographic longitude (radians)
[in]latitudeObserver geographic latitude (radians)
[in]elevation_mObserver elevation (meters)
[in]pressure_hPaAtmospheric pressure (HPa)
[in]temperature_celsiusTemperature (degrees Celsius)
[in]relative_humidityRelative humidity (0.0 - 1.0)
[in]dut1UTC - UT1
[in]xp"x" polar motion
[in]yp"y" polar motion
[in]wavelength_umWavelength (micrometers)

Definition at line 1041 of file CECoordinates.cpp.

◆ Observed2ICRS() [1/2]

int CECoordinates::Observed2ICRS ( double  az,
double  zen,
double *  ra,
double *  dec,
const CEDate date,
const CEObserver observer,
const CEAngleType angle_type = CEAngleType::RADIANS 
)
static

Convert Observed -> ICRS coordinates.

Parameters
[in]azAzimuth of the coordinates
[in]zenZenith angle of the coordinates
[out]raCIRS right ascension (returned)
[out]decCIRS declination (returned)
[in]observerCEObserver object describing observer
[in]angle_typeAngle type of input/output coordinates

Definition at line 608 of file CECoordinates.cpp.

◆ Observed2ICRS() [2/2]

int CECoordinates::Observed2ICRS ( double  az,
double  zen,
double *  ra,
double *  dec,
double  julian_date,
double  longitude,
double  latitude,
double  elevation_m = 0.0,
double  pressure_hPa = -1.0,
double  temperature_celsius = -1000,
double  relative_humidity = 0.0,
double  dut1 = 0.0,
double  xp = 0.0,
double  yp = 0.0,
double  wavelength_um = 0.5 
)
static

Raw method for converting Observed (observer specific) -> ICRS coordinates Note: All angles are expected to be in radians.

Parameters
[in]azObserved azimuth angle (radians)
[in]zenObserved zenith angle (radians)
[out]raICRS right ascension (radians, returned)
[out]decICRS declination (radians, returned)
[in]julian_dateJulian date for conversion
[in]longitudeObserver geographic longitude (radians)
[in]latitudeObserver geographic latitude (radians)
[in]elevation_mObserver elevation (meters)
[in]pressure_hPaAtmospheric pressure (HPa)
[in]temperature_celsiusTemperature (degrees Celsius)
[in]relative_humidityRelative humidity (0.0 - 1.0)
[in]dut1UTC - UT1
[in]xp"x" polar motion
[in]yp"y" polar motion
[in]wavelength_umWavelength (micrometers)

Definition at line 911 of file CECoordinates.cpp.

◆ operator=()

CECoordinates & CECoordinates::operator= ( const CECoordinates other)

Overloaded '=' (assignment) operator.

Parameters
[in]otherCoordinates object to be copied
Returns
Duplicated CECoordinates object

Definition at line 122 of file CECoordinates.cpp.

◆ print()

std::string CECoordinates::print ( void  ) const

Generate a message string that specifies the information about this coordinate.

Returns
String describing this object

Definition at line 1705 of file CECoordinates.cpp.

◆ SetCoordinates() [1/2]

void CECoordinates::SetCoordinates ( const CEAngle xcoord,
const CEAngle ycoord,
const CECoordinateType coord_type = CECoordinateType::ICRS 
)
virtual

Set the coordinates of this object.

Parameters
[in]xcoordX-coordinate
[in]ycoordY-coordinate
[in]coord_typeCoordinate type (see CECoordinateType)
[in]angle_typeSpecifies whether xcoord & ycoord are in RADIANS or DEGREES (see CEAngleType)

Definition at line 1682 of file CECoordinates.cpp.

◆ SetCoordinates() [2/2]

void CECoordinates::SetCoordinates ( const CECoordinates coords)
virtual

Set the coordinates from another CECoordinates object.

Parameters
[in]coordsAnother coordinates object to copy

Definition at line 1695 of file CECoordinates.cpp.

◆ XCoord()

CEAngle CECoordinates::XCoord ( const double &  jd = CppEphem::julian_date_J2000()) const
inlinevirtual

Return x coordinate at given Julian date.

Parameters
[in]jdJulian date (used only by derived classes)
Returns
X-coordinate as a CEAngle

Definition at line 411 of file CECoordinates.h.

◆ XCoordinate_Deg()

double CECoordinates::XCoordinate_Deg ( double  jd = CppEphem::julian_date_J2000()) const
inlinevirtual

Returns x coordinate at given julian date in degrees.

Parameters
[in]jdJulian date (used only by derived classes)
Returns
X-coordinate in degrees

Definition at line 450 of file CECoordinates.h.

◆ XCoordinate_Rad()

double CECoordinates::XCoordinate_Rad ( double  jd = CppEphem::julian_date_J2000()) const
inlinevirtual

Return x coordinate at given Julian date in radians.

Parameters
[in]jdJulian date (used only by derived classes)
Returns
X-coordinate in radians

Definition at line 437 of file CECoordinates.h.

◆ YCoord()

CEAngle CECoordinates::YCoord ( const double &  jd = CppEphem::julian_date_J2000()) const
inlinevirtual

Return y coordinate at given Julian date.

Parameters
[in]jdJulian date (used only by derived classes)
Returns
X-coordinate as a CEAngle

Definition at line 424 of file CECoordinates.h.

◆ YCoordinate_Deg()

double CECoordinates::YCoordinate_Deg ( double  jd = CppEphem::julian_date_J2000()) const
inlinevirtual

Returns y coordinate at given Julian date in degrees.

Parameters
[in]jdJulian date (used only by derived classes)
Returns
Y-coordinate in degrees

Definition at line 475 of file CECoordinates.h.

◆ YCoordinate_Rad()

double CECoordinates::YCoordinate_Rad ( double  jd = CppEphem::julian_date_J2000()) const
inlinevirtual

Returns y coordinate at given Julian date in radians.

Parameters
[in]jdJulian date (used only by derived classes)
Returns
Y-coordinate in radians

Definition at line 463 of file CECoordinates.h.

Friends And Related Function Documentation

◆ operator!=

bool operator!= ( const CECoordinates lhs,
const CECoordinates rhs 
)
friend

Compare two coordinate objects.

Returns
True if two coordinates are NOT equal to each other

Definition at line 1778 of file CECoordinates.cpp.

◆ operator==

bool operator== ( const CECoordinates lhs,
const CECoordinates rhs 
)
friend

Compare two coordinate objects.

Returns
True if the two coordinates are equal to each other

Definition at line 1751 of file CECoordinates.cpp.

Member Data Documentation

◆ coord_type_

CECoordinateType CECoordinates::coord_type_
protected

Definition at line 387 of file CECoordinates.h.

◆ xcoord_

CEAngle CECoordinates::xcoord_
mutableprotected

Definition at line 385 of file CECoordinates.h.

◆ ycoord_

CEAngle CECoordinates::ycoord_
mutableprotected

Definition at line 386 of file CECoordinates.h.


The documentation for this class was generated from the following files: