Click or drag to resize

AGI.Foundation.Celestial Namespace

Contains types used in modeling characteristics of celestial objects and celestial phenomena.
Classes
  ClassDescription
Public classArielCentralBody
The Uranian moon Ariel. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classAtmosphericDragForce
A simple model of atmospheric drag on a body according to its coefficient of drag and reference cross-sectional area. This model does not account for aerodynamic lift and is generally used for orbiting bodies which are perturbed by the atmosphere. The details of the model are specified by choosing which density model to use for the atmosphere.
Public classAtmosphericRefractionModel
Defines a refraction model.
Public classCallistoCentralBody
The Jovian moon Callisto. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classCentralBodiesFacet
A CalculationContextFacet that holds and provides information about central bodies such as planets, moons, the sun, etc.
Public classCentralBody
A central body, such as a planet, star, asteroid, libration point, etc.
Public classCentralBodyInertialAxes
This class provides the Axes based on the STK definition of a CentralBody's Inertial Axes. The Inertial Z axis aligns with the IauOrientationAxes Z axis of the CentralBody, and the Inertial X axis aligns with the vector that is the cross product of the InternationalCelestialReferenceFrame Z axis and the IAU Z axis, evaluated at the J2000 epoch.
Public classCentralBodyIntersection
A utility for checking for orbit intersection with a planet given two-body dynamics.
Public classCeresCentralBody
The dwarf planet Ceres. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classCharonCentralBody
The Plutonian moon Charon. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classClassicalEquationOfEquinoxes

Represents the classical equation of the equinox as defined in the Explanatory Supplement to the Astronomical Almanac. This equation has been in use for many decades. For the updated equation of equinoxes defined by the IERS in 1996, see IersTechnicalNote21. To apply this equation of equinoxes, replace the existing EquationOfEquinoxes with an instance of this class.

This class uses the existing NutationModel and PrecessionModel.

Public classConstantForce
Represents a constant force.
Public classConstantSolarGeophysicalData
Represents the solar radiation and geomagnetic flux indices as constant values.
Public classConstantTorque
Represents a constant torque.
Public classConstantWindModel
Represents a constant wind speed and direction.
Public classContinuousThrustForceModel
Represents a force generated by continuous thrust.
Public classCssiSolarGeophysicalData
Represents the solar radiation and geomagnetic flux indices as they vary over time. For more details, or to obtain updated data files, see: CSSI Space Weather Data.
Public classDawnCeresVestaOrientation
This is a collection of the orientation information available for Ceres and Vesta. The data comes from results of the Dawn mission to Ceres and Vesta.
Public classDeimosCentralBody
The Martian moon Deimos. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classDioneCentralBody
The Saturnian moon Dione. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classDragBodyPlate
A model of a discrete surface element of a spacecraft's body that has a surface area, unit normal direction, and a drag coefficient.
Public classDragOneDofSolarPanelPlate
A model of a discrete surface element of a spacecraft's solar panels that points toward the Sun as much as it can while being constrained by a single rotational degree of freedom about a specified rotation axis.
Public classDragPlate
A model of a discrete surface element of a spacecraft that has a surface area, unit normal direction, and a drag coefficient.
Public classDragTwoDofSolarPanelPlate
A model of a discrete surface element of a spacecraft's solar panels that always points toward the Sun.
Public classCode exampleEarthCentralBody
The planet Earth. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classEarthGravitationalModel1996
Provides the semimajor axis, gravitational parameter, and 2nd, 3rd, 4th, and 5th zonal harmonic coefficients for the Earth Gravitational Model of 1996 (EGM96) according to NASA Technical Publication 1998-206861.
Public classEarthGravitationalModel2008
Provides the semimajor axis, gravitational parameter, and 2nd, 3rd, 4th, and 5th zonal harmonic coefficients for the Earth Gravitational Model of 2008 (EGM2008) according to the Journal of Geophysical Research, Vol 117, Issue B4, April 2012.
Public classEarthMoonBarycenter
The barycenter of the Earth-Moon system. Used when the Earth-Moon system is modeled as a single third body in interplanetary trajectories.
Public classEarthOrientationParameters
Specifies Earth polar motion coordinates and the difference between UT1 and UTC.
Public classEarthOrientationParametersData
Specifies Earth Orientation Parameters at a specific instant.
Public classEarthOrientationParametersFile
Contains static methods to read EOP data in the Celestrak EOP data file format which is documented at https://celestrak.com/SpaceData/EOP-format.asp.
Public classEarthOrientationParametersReadOptions
Specifies options for reading an EarthOrientationParametersFile.
Public classEffectiveRadiusAtmosphericRefractionModel
The effective radius model approximates the effects of refraction by assuming that the refractive index decreases linearly with altitude. This is only valid for objects at low altitude, typically less than 8-10 km. This approximation leads to a very simple formula for the refracted elevation angle that is akin to computing the elevation angle relative to a scaled Earth surface. The Earth's radius is scaled by the effective radius factor, typically a value between 0.3 and 2 -- the most common value is 4/3. Note that the model does not provide a manner for computing the effect of refraction on the signal path length.
Public classEnceladusCentralBody
The Saturnian moon Enceladus. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classEquationOfEquinoxes

Represents the equation of the equinox (also called the "nutation in right ascension" according to the Explanatory Supplement to the Astronomical Almanac) which defines the right ascension of the mean equinox with respect to the true equator and equinox.

The two primary theories of the equation of the equinoxes are the ClassicalEquationOfEquinoxes and the UpdatedEquationOfEquinoxes. To apply a particular theory to calculations involving the Earth, obtain an instance of the EarthCentralBody from the CentralBodiesFacet and replace the existing EquationOfEquinoxes with a new instance.

Public classEuropaCentralBody
The Jovian moon Europa. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classForceEvaluator
Base class for evaluators created by a ForceModel to compute the force.
Public classForceModel
Represents a Newtonian force which can be used to specify the equations of motion for a mass body located by a PropagationNewtonianPoint.
Public classGanymedeCentralBody
The Jovian moon Ganymede. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classGravityGradientTorque
Represents the gravity-gradient torque effects on a satellite parameterized by a PropagationNewtonianPoint and a PropagationEulerianAxes.
Public classHyperionCentralBody
The Saturnian moon Hyperion. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classIapetusCentralBody
The Saturnian moon Iapetus. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classIau1976Precession
Provides Earth precession information according to the IAU 1976 model
Public classIau1980Nutation
Provides Earth Nutation information according to the IAU 1980 model
Public classIau2000Orientation
This is a collection of the orientation information available for central bodies. The data comes from the Report of the IAU/IAG Working Group on Cartographic Coordinates and Rotational Elements: 2000.
Public classIau2006Orientation
This is a collection of the orientation information available for central bodies. The data comes from the Report of the IAU/IAG Working Group on Cartographic Coordinates and Rotational Elements: 2006.
Public classIau2006XysData
A table of IAU2006 XYS data that is used to evaluate the transformation between the International Celestial Reference Frame (ICRF) and the International Terrestrial Reference Frame (ITRF). It is usually preferable to use the ReferenceFrame instances on EarthCentralBody rather than using this table directly.
Public classIau2009Orientation
This is a collection of the orientation information available for central bodies. The data comes from the Report of the IAU/IAG Working Group on Cartographic Coordinates and Rotational Elements: 2009.
Public classIau2015Orientation
This is a collection of the orientation information available for central bodies. The data comes from the Report of the IAU/IAG Working Group on Cartographic Coordinates and Rotational Elements: 2015.
Public classIauOrientationAxes
The Axes representing the orientation of a CentralBody as represented by the data from the IAU/IAG Working Group reports on rotational elements expressed in the InertialAxes of the SolarSystemBarycenter. See Iau2009Orientation for more details.
Public classIauOrientationParameters
A structure containing the orientation data computed at a particular time. The data represent the direction of the pole of rotation and the rotation about that pole.
Public classIers2003SolidTideModel
A high-fidelity, time-varying Earth solid tide model that is based on the IERS Conventions (2003) technical report 32.
Public classIersTechnicalNote21
Provides Earth orientation parameters according to the IERS Technical Note 21.
Public classIersTechnicalNote36RelativisticCorrectionForce
A NewtonianSpecificForce that models the first order correction to the acceleration of a space object about a CentralBody. The mathematical details for this model may be found in chapter 10 of "IERS Conventions (2010)". The model was primarily designed for artificial satellites about Earth, but may be used with any space object and any CentralBody in the solar system. The force always returns the primary contributor to the correction, the Schwarzchild field of the central body. By default, corrections for frame-dragging and precession of the geodesic are also included, but may be turned off if so desired.
Public classIndividualPlateModel
A model of a discrete surface element of a spacecraft that has a surface area, unit normal direction, and drag or reflectivity coefficients.
Public classInternationalGeomagneticReferenceFieldVector
Represents the magnetic field vector at a point due to the Earth's magnetic field, as modeled by an IGRF model.
Public classIoCentralBody
The Jovian moon Io. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classItuRP834Version4AtmosphericRefractionModel
ITU-R P.834-4 is the ITU recommendation concerning "Effects of tropospheric refraction on radio wave propagation." The recommendation provides an analytical formula for the refracted elevation at the ground. The higher platform is assumed to be a satellite. More information is available at ITU Radiocommunication Sector. Note that the model does not provide a manner for computing the effect of refraction on the signal path length.
Public classJovianMoonsAnalyticEphemeris
Provides Point instances representing the positions of some of the Jovian moons computed using a J4Propagator with gravitational terms provided by the comments file for the jup365 ephemeris file.
Public classJplDE
The common base for classes for loading and accessing JPL DE files.
Public classCode exampleJplDE200
Represents JPL DE200 ephemeris data.
Public classCode exampleJplDE403
Represents JPL DE403 ephemeris data.
Public classCode exampleJplDE405
Represents JPL DE405 ephemeris data.
Public classCode exampleJplDE421
Represents JPL DE421 ephemeris data.
Public classCode exampleJplDE430
Represents JPL DE430 ephemeris data.
Public classCode exampleJplDE440
Represents JPL DE440 ephemeris data.
Public classJplDEFile
Provides raw access to a JPL DE file.
Public classJplDEFileEvaluator
The class returned by GetEvaluator(JplDEDataIndex, EvaluatorGroup) to allow calculation of time-varying information in the JPL DE file.
Public classJupiterCentralBody
The planet Jupiter. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classJupiterSystemBarycenter
The barycenter of the Jupiter system. Used to define the orbits of Jupiter's satellites.
Public classLibrationModel
A model of the libration of a central body.
Public classLinkRefracted
A link between a Transmitter and Receiver that travels a refracted path. The refracted link relies on an underlying ExtensibleObject link instance as well as a AtmosphericRefractionModel refraction model as the basis for computing the refracted link. In this way, a refracted link which also accounts for light travel time can be achieved by configuring the refracted link with a LinkSpeedOfLight instance as the underlying link. Or if light travel time is not important to the analysis, the LinkInstantaneous can be used as the basis for refraction.
Public classMagneticCoilTorque
Represents the torque effects of a magnetic field vector on a magnetic torquer coil implemented on a spacecraft parameterized by a PropagationEulerianAxes.
Public classMagneticFieldVector
Represents the magnetic field vector at a point due to a planetary magnetic field.
Public classMarsCentralBody
The planet Mars. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classMarsSystemBarycenter
The barycenter of the Mars system. Used to define the orbits of Phobos and Deimos.
Public classMartianMoonsAnalyticEphemeris
Provides Point instances representing the positions of the Martian moons computed using a J4Propagator with gravitational terms provided by the comments file for the mar097 ephemeris file.
Public classMercuryCentralBody
The planet Mercury. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classMimasCentralBody
The Saturnian moon Mimas. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classCode exampleMoonCentralBody
The moon of the Earth. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classNeptuneCentralBody
The planet Neptune. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classNeptuneSystemBarycenter
The barycenter of the Neptune system. Used to define the orbits of Neptune's satellites.
Public classNeptunianMoonsAnalyticEphemeris
Provides Point instances representing the positions of one of the Neptunian moons computed using a J4Propagator with gravitational terms provided by the comments file for the nep097 ephemeris file.
Public classNPlateAtmosphericDragForce

A medium-fidelity force model for atmospheric drag on a spacecraft. The model requires that a spacecraft's attitude be specified by its body axes, the spacecraft's body and solar panels be modeled by an N-Plate model that contains a model for each outward facing surface of the spacecraft, and the atmospheric density is modeled by a density model.

This model does not take into account the effect of plates physically blocking other plates from experiencing drag if the blocked plates are behind them but pointing in the same direction.

Public classNPlateModel
A collection that models the spacecraft's body as a collection of individual plates with surface areas, body-fixed directions, and drag or reflectivity coefficients.
Public classNPlateSolarRadiationForce

A medium-fidelity force model for solar radiation pressure on a spacecraft. The model requires that a spacecraft's attitude be specified by its body axes and that the spacecraft's body and solar panels be modeled by an N-Plate model that contains a model for each outward facing surface of the spacecraft.

This model does not take into account the effect of plates physically blocking other plates from experiencing pressure if the blocked plates are behind them but pointing in the same direction. (This effect is sometimes called self-shadowing).

Public classNutation
Holds nutation angles in longitude and in obliquity.
Public classNutationModel
A model of the nutation of a central body.
Public classOffAxisTorque
Represents the torque effects of a thruster that is not aligned with the center of mass of a a vehicle parameterized by a PropagationEulerianAxes.
Public classPermanentSolidTideModel
A constant solid tide model that can add permanent tides to a tide-free model to form a zero-tide model.
Public classPhobosCentralBody
The Martian moon Phobos. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classPhoebeCentralBody
The Saturnian moon Phoebe. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classPlanetarySystemBarycenter
The barycenter of a planetary system. Used to define the orbits of planetary satellites.
Public classPlutoCentralBody
The dwarf planet Pluto. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classPlutonianMoonsAnalyticEphemeris
Provides Point instances representing the positions of one of the Plutonian moons computed using a TwoBodyPropagator with gravitational parameter provided by the comments file of the plu043 ephemeris file.
Public classPlutoSystemBarycenter
The barycenter of the Pluto system. Used to define the orbits of Pluto's satellites.
Public classPrecession
Holds precession angles.
Public classPrecessionModel
A model of the precession of a central body.
Public classReactionWheelTorque
Represents the torque effects of a reaction wheel implemented on a spacecraft parameterized by a PropagationEulerianAxes.
Public classResultantForceBuilder
A tool used by ForceModel objects to add their Principal and Perturbation forces to a list of forces in a resultant force.
Public classResultantTorqueBuilder
A tool used by TorqueModel objects to add to a list of torques in a resultant torque.
Public classRheaCentralBody
The Saturnian moon Rhea. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classSaturnCentralBody
The planet Saturn. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classSaturnianMoonsAnalyticEphemeris
Provides Point instances representing the positions of some of the Saturnian moons computed using a J4Propagator with gravitational terms provided by the comments file of the sat441 ephemeris file.
Public classSaturnSystemBarycenter
The barycenter of the Saturn system. Used to define the orbits of Saturn's satellites.
Public classScalarAtmosphericDensity
Abstract base class for all atmospheric models used to calculate density.
Public classScalarDensityJacchia1970
Calculates atmospheric density according to the Jacchia 1970 model. The Jacchia models depend on the VectorToSun to determine the shape of the atmosphere based on incident solar radiation.
Public classScalarDensityJacchiaRoberts
Calculates atmospheric density according to the Jacchia-Roberts model. The Jacchia models depend on the VectorToSun to determine the shape of the atmosphere based on incident solar radiation.
Public classScalarDensityMsis2000

Calculates atmospheric density according to the NRLMSISE 2000 model.

MSIS 2000 is applicable from 0 km to 1000 km in altitude, and is meant for applications that reach across several atmospheric boundaries. It is not recommended for specialized tropospheric work, and if you are interested only in the thermosphere (120 km+) MSIS-86 is recommended instead.

MSIS 2000 was developed by the US Naval Research Laboratory. More information and documentation is available at http://modelweb.gsfc.nasa.gov/atmos/

Unlike other density models, this type does not make use of the VectorToSun and instead determines the shape of the atmosphere purely based on the time of day.

If available, the MSIS models will make use of the time varying daily averages for the geomagnetic flux defined by the SolarGeophysicalData instance.

Public classScalarDensityMsis86

Calculates atmospheric density according to the MSIS 1986 model.

The Mass-Spectrometer-Incoherent-Scatter-1986 (MSIS-86) neutral atmosphere model describes the neutral temperature and the densities of He, O, N2, O2, Ar, H, and N. The MSIS model is based on the extensive data compilation and analysis work of A. E. Hedin and his collaborators [A. E. Hedin et al., J. Geophys. Res. 82, 2139-2156, 1977; A. E. Hedin, J. Geophys. Res. 88, 10170- 10188, 1983; A. E. Hedin, J. Geophys. Res. 92, 4649, 1987]. MSIS-86 constitutes the upper part of the COSPAR International Reference Atmosphere (CIRA-86).

Unlike other density models, this type does not make use of the VectorToSun and instead determines the shape of the atmosphere purely based on the time of day.

If available, the MSIS models will make use of the time varying daily averages for the geomagnetic flux defined by the SolarGeophysicalData instance.

Public classScalarDensityMsis90

Calculates atmospheric density according to the MSIS 1990 model.

This method is built off of the Fortran code written by Hedin et al. It is valid over the entire atmosphere. Above 72.5 km it is basically an updated MSIS 1986 density model, below 72.5 km it is based on the MAP Handbook (Labitzke et al., 1985), supplemented by other data.

Unlike other density models, this type does not make use of the VectorToSun and instead determines the shape of the atmosphere purely based on the time of day.

If available, the MSIS models will make use of the time varying daily averages for the geomagnetic flux defined by the SolarGeophysicalData instance.

Public classScalarOccultation

A class that provides evaluators for percentage of occultation/eclipse at a position, as well as EclipseType.

The percentage runs from 0.0 (completely lit) to 1.0 (total eclipse).

Public classScalarOccultationCylindrical

Provides evaluators for percentage of occultation/eclipse at a position, as well as EclipseType using the cylindrical shadow model.

The percentage runs from 0.0 (completely lit) to 1.0 (total eclipse).

This occultation model is not nearly as accurate as ScalarOccultationDualCone, which should generally be used instead. However this cylindrical model was included for completeness.

Public classScalarOccultationDualCone

Provides evaluators for percentage of occultation/eclipse at a position, as well as EclipseType using the dual cone shadow model.

The percentage runs from 0.0 (completely lit) to 1.0 (total eclipse).

This occultation model is much more accurate than ScalarOccultationCylindrical and is the one which should be used in most cases.

Public classScalarOccultationNoShadow

This is a ScalarOccultation for use with SimpleSolarRadiationForce. This type models a lack of any shadow conditions, and is primarily intended for interplanetary missions.

The same effect can be attained by using another ScalarOccultation without any bodies added to the OccludingBodies property, however this type has also been added for convenience.

Public classScalarOccultationRegulatedDualCone

Provides evaluators for percentage of occultation/eclipse at a position, as well as EclipseType using the dual cone shadow model.

The percentage runs from 0.0 (completely lit) to 1.0 (total eclipse).

This shadow model should only be used in a SimpleSolarRadiationForce in conjunction with SolarRadiationBoundaryMitigation. It performs differently than the normal ScalarOccultationDualCone in that it treats the penumbra shadow condition as umbra, and does not allow the occultation factor to change during a propagation step. This functionality is required for correct results from the boundary mitigator, but in all other circumstances the normal dual cone occultation model should be used.

Public classScalarVariableArea
A Scalar that enables interpolation of spacecraft area data from .dat files to use as a reference area for AtmosphericDragForce and SimpleSolarRadiationForce.
Public classScalarVariableAreaArgumentLatitude
A Scalar that enables interpolation of spacecraft area data to use as a reference area for AtmosphericDragForce and SimpleSolarRadiationForce.
Public classScalarVariableAreaJulianDate
A Scalar that enables interpolation of spacecraft area data to use as a reference area for AtmosphericDragForce and SimpleSolarRadiationForce.
Public classSimon1994PlanetaryPositions
Provides Point instances representing the positions of the planets computed using the equations described in Simon J.L., Bretagnon P., Chapront J., Chapront-Touze M., Francou G., Laskar J., 1994, A&A 282, 663-683.
Public classSimpleSolarRadiationForce
Represents the acceleration from solar radiation pressure exerted on the given reflective area at the target position.
Public classSimpleSolidTideModel
A simplified, time-varying solid tide model.
Public classSmallSolarSystemBodyAnalyticEphemeris

Provides Point instances representing the positions of a selection of dwarf planets and other small solar system bodies based on the osculating orbital elements defined at reference epochs by the Small-Body Database maintained by the Solar System Dynamics group of JPL.

Public classSolarGeophysicalData
This class holds information on the F10.7 solar flux and the kp and ap geomagnetic flux.
Public classSolarRadiationBodyPlate
A model of a discrete surface element of a spacecraft's body that has a surface area, unit normal direction, a specular reflectivity coefficient, and a diffuse reflectivity coefficient.
Public classSolarRadiationBoundaryMitigation
Corrects for eclipse crossings during satellite propagation.
Public classSolarRadiationOneDofSolarPanelPlate
A model of a discrete surface element of a spacecraft's solar panels that points toward the Sun as much as it can while being constrained by a single rotational degree of freedom about a specified rotation axis.
Public classSolarRadiationPlate
A model of a discrete surface element of a spacecraft that has a surface area, unit normal direction, a specular reflectivity coefficient, and a diffuse reflectivity coefficient.
Public classSolarRadiationTwoDofSolarPanelPlate
A model of a discrete surface element of a spacecraft's solar panels that always points toward the Sun.
Public classSolarSystemBarycenter
The barycenter of a solar system.
Public classSolidTideModel
A solid tide model that could be permanent or time-varying.
Public classSpaceControlFacilityAtmosphericRefractionModel
The Satellite Control Facility (SCF) refraction model is based upon the paper "Refraction Correction, 'RC, Refraction Addition, 'RA, Milestone 4, Model 15.3A" by A. M. Smith, Aug 1978. The 'RC model (pronounced tick-R-C) provides analytical formulas for computing the refraction angle and the refracted range (i.e., the effect of refraction on the signal path) of an observer on the ground to a satellite target. The formulas depend on the surface refractivity at the ground site.
Public classSphericalHarmonicCoefficients
Contains the coefficient data for a spherical harmonic model.
Public classSphericalHarmonicGravity
Represents the acceleration (force for a given unit mass) at a particular point from the gravitational effects of the distribution of the Earth's mass.
Public classSphericalHarmonicGravityField
The immutable class that describes the chosen subset and configuration of spherical harmonic gravitational model.
Public classSphericalHarmonicGravityModel
Contains the coefficient data for a gravity model, either specified upon construction or read in from a file. This type is passed to a SphericalHarmonicGravityField which down selects to the desired subset of this full model, and sets other configuration options. The field is then used by SphericalHarmonicGravity in order to calculate the gravitational force.
Public classSphericalHarmonicGravitySecularVariations
A linear model for the secular variations of a gravity model.
Public classCode exampleSunCentralBody
The star at the center of our solar system. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classTethysCentralBody
The Saturnian moon Tethys. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classThirdBodyGravity
Represents the gravitational acceleration created by bodies other than the central body around which a target object is orbiting.
Public classThirdBodyGravityThirdBodyInfo
A combination of the position and gravitational parameter for a perturbing gravitational body.
Public classTimeVaryingSolidTideModel
A solid tide model that must vary with time.
Public classTitanCentralBody
The Saturnian moon Titan. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classTitaniaCentralBody
The Uranian moon Titania. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classTorqueEvaluator
Base class for evaluators created by a TorqueModel to compute the torque.
Public classTorqueModel
Represents a torque which can be used to specify the equations of rotational motion for a rigid-body parameterized by a PropagationEulerianAxes.
Public classTritonCentralBody
The Neptunian moon Triton. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classTwoBodyGravity
Represents the acceleration from a simple two body gravity model.
Public classUranianMoonsAnalyticEphemeris
Provides Point instances representing the positions of some of the Uranian moons computed using a J4Propagator with gravitational terms provided by the comments file of the ura111 ephemeris file.
Public classUranusCentralBody
The planet Uranus. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classUranusSystemBarycenter
The barycenter of the Uranus system. Used to define the orbits of Uranus's satellites.
Public classUSStandardAtmosphere1976
Provides scalars that calculate values using the U.S. Standard Atmosphere model, 1976 version. This model is defined with respect to mean sea level, so you must configure the MeanSeaLevel property on EarthCentralBody before using this model.
Public classUSStandardAtmosphere1976Result
The result of the calculation.
Public classVectorRefractedDisplacement
A vector representing the refracted displacement from an initial point to a final point as both points move over time. The refracted displacement vector relies on an underlying VectorDisplacement instance as well as an AtmosphericRefractionModel as the basis for computing the refracted displacement vector. In this way, a refracted displacement vector which also accounts for light travel time can be achieved by configuring the refracted displacement vector with a VectorApparentDisplacement instance as the underlying unrefracted displacement vector. If light travel time is not important to the analysis, the VectorTrueDisplacement can be used as the basis for refraction.
Public classVenusCentralBody
The planet Venus. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classVestaCentralBody
The asteroid Vesta. You should generally obtain an instance of this class from the CentralBodiesFacet instance in the calculation context instead of creating one directly.
Public classWindModel
Defines a wind model for an atmosphere.
Public classWorldGeodeticSystem1984
Provides the set of four World Geodetic System of 1984, WGS84 (G873), defining constants according to Table 3.1 on page 3-5 of the National Imagery and Mapping Agency Technical Report TR8350.2, Third Edition, Amendment 1, 3 January 2000.
Public classWorldMagneticModelVector
Represents the magnetic field vector at a point due to the Earth's magnetic field, as modeled by a WMM model.
Interfaces
  InterfaceDescription
Public interfaceIJplDEWithMoonLibrationModel
A JplDE which can return a libration model for the Moon.
Delegates
  DelegateDescription
Public delegateCentralBodyInertialAxesComputeOrientationParameters
The definition of a function which computes a set of orientation parameters.
Public delegateComputeIauOrientationParameters
The definition of a function which computes a set of orientation parameters.
Enumerations
  EnumerationDescription
Public enumerationCoefficientOfReflectivityType
Defines the type of Reflectivity Coefficient used in initializing SimpleSolarRadiationForce.
Public enumerationEclipseType
Enumerates the different types of shadowing that can occur during an eclipse.
Public enumerationJplDECentralBody
The central bodies referenced in a JPL DE file.
Public enumerationJplDEDataIndex
Indices of the data available in a JPL DE file.
Public enumerationKindOfForce
Indicates the properties of a given force to be used when distinguishing the behavior of forces when defining equations of motion.
Public enumerationRadiationVectorType
Defines the type of vector to use between the target and the illuminating body in context of scalar occultation.
Public enumerationRoleOfForce
An indication of how important a given force is in the overall composite force acting on a given object. Certain integrators will use this information to optimize the efficiency of evaluating the equations of motion during propagation of forces.