Classes | |
class | O_SESSAME::Attitude |
Class encapsulating the rotational attitude of a rigid body frame with respect to another frame. More... | |
class | O_SESSAME::AttitudeState |
class | O_SESSAME::AttitudeHistory |
Class for storing a time history of attitude states. More... | |
class | O_SESSAME::History |
Base class for histories storing state variables, also stores time states. More... | |
class | O_SESSAME::OrbitHistory |
Class for storing a time history of orbital states. More... | |
class | O_SESSAME::AnalyticPropagator |
Encapsulation of the propagation of the spacecraft dynamics (attitude, orbital, etc.). More... | |
class | O_SESSAME::CombinedNumericPropagator |
class | O_SESSAME::NumericPropagator |
class | O_SESSAME::Propagator |
Encapsulation of the propagation of the spacecraft dynamics (attitude, orbital, etc.). More... | |
class | O_SESSAME::CentralBody |
Abstract representation of a central body. More... | |
class | O_SESSAME::EarthCentralBody |
struct | O_SESSAME::MagneticFieldCoefficients |
Structure to hold typical magnetic model coefficients. More... | |
class | O_SESSAME::MagneticModel |
The MagneticModel class encapsulates a magnetic model of a central body. More... | |
class | O_SESSAME::TiltedDipoleMagneticModel |
Define the model of a magnetic field using a tilted dipole model. More... | |
class | O_SESSAME::EnvFunction |
class | O_SESSAME::Environment |
Encapsulation of a spacecraft environment (disturbance forces, torques, central body, etc.). More... | |
class | O_SESSAME::Orbit |
class | O_SESSAME::OrbitState |
Encapsulation of an Orbit State, including its coordinate type and reference frame. More... | |
struct | O_SESSAME::tleStruct |
class | O_SESSAME::Keplerian |
Keplerian orbital element representation of the orbital position. More... | |
class | O_SESSAME::OsculatingOrbitalElements |
Keplerian Osculating and Mean orbital element representation of the orbital position. More... | |
class | O_SESSAME::OrbitStateRepresentation |
Abstract base type of the orbit state representation. More... | |
class | O_SESSAME::PositionVelocity |
Position & Velocity representation of the orbital position. More... | |
class | O_SESSAME::TestKeplerian |
Test Keplerian orbital class. More... | |
class | O_SESSAME::DirectionCosineMatrix |
3x3 direction cosine matrix attitude representation. More... | |
class | O_SESSAME::ModifiedRodriguezParameters |
3x1 Modified Rodriguez Parameters attitude representation. More... | |
class | O_SESSAME::Quaternion |
The non-singular, redundant Euler parameter (quaternion) vector. More... | |
class | O_SESSAME::Rotation |
A generalized rotation class to represent any attitude coordinate transformation. More... | |
class | O_SESSAME::Functor |
Abstract class to hold the pointer to an force calculating functor. More... | |
class | O_SESSAME::SpecificFunctor |
derived template class More... | |
class | O_SESSAME::ObjectFunctor< TClass > |
derived template class More... | |
class | O_SESSAME::Integrator |
Interface class to the Integrator algorithm strategies. More... | |
class | O_SESSAME::Interpolator |
Abstract interface to the set of interpolators. More... | |
class | O_SESSAME::LinearInterpolator |
Interpolates between a given set of data points to create a linear functional approximation. More... | |
class | O_SESSAME::Plot |
A Plot object is used to display data in a 2-D or 3-D plot. More... | |
class | O_SESSAME::RungeKuttaFehlbergIntegrator |
Runge-Kutta-Fehlberg integrator. More... | |
class | O_SESSAME::RungeKuttaIntegrator |
Implementation of a Runge-Kutta (Fourth Order) Integrator. More... | |
class | O_SESSAME::ssfTime |
Simulation Time object. More... | |
Typedefs | |
typedef void(* | IntegratedAttitudeStateConversionFunction )(const Matrix &_meshPoint, AttitudeState &_convertedAttitudeState) |
Defined function pointer to integrated attitude state conversion function. | |
typedef int | AttitudeFrame |
typedef vector< void * > | EnvFuncParamaterType |
typedef Vector(* | pt2EnvFunc )(const ssfTime &_currentTime, const OrbitState &_currentOrbitState, const AttitudeState &_currentAttitudeState, const EnvFuncParamaterType &_parameterList) |
typedef CAMdoubleMatrix | Matrix |
typedef CAMdoubleVector | Vector |
typedef void(* | IntegratedOrbitStateConversionFunction )(const Matrix &_meshPoint, OrbitState &_convertedOrbitState) |
Defined function pointer to integrated orbital state conversion function. | |
typedef Vector(* | vectorFuncPtr )(const Vector &_vectorFuncPtrParams) |
A generalized pointer to a function that takes a vector as a parameter and returns a vector. | |
typedef Vector(* | odeFunc )(const double &_time, const Vector &_state, const Matrix &_parameters, vectorFuncPtr _funcPtr) |
defines a pointer to an integrator's right-hand side (RHS) function | |
typedef Vector(* | odeFunctor )(const ssfTime &_time, const Vector &_integratingState, Orbit *_pOrbit, Attitude *_pAttitude, const Matrix &_parameters, const Functor &_forceFunctorPtr) |
defines a pointer to an integrator's right-hand side (RHS) function using a functor for the arbitrary vector function | |
typedef double | Angle |
Representation of an angle in radians. Currently the angle representation is assumed to be radians, and can be used in any of the other Trigonometry functions to convert to Degrees or Degrees-Minutes-Seconds. In the future, the Angle should be a class that is unit independent and include the appropriate conversion functions. | |
typedef double | ssfSeconds |
typedef double | ssfJulianDate |
Enumerations | |
enum | RotationType { DCM_Type, EulerAngle_Type, EulerAxisAngle_Type, MRP_Type, Quaternion_Type } |
Various representations of a rotation. More... | |
enum | RotationSense { LEFT_HAND = -1, RIGHT_HAND = 1 } |
The Sense, or "handedness" of a rotation system. More... | |
Functions | |
Vector | Vabs (Vector _vector) |
Returns the absolute value of a vector. | |
Matrix | eye (int _rowColumns) |
Creates an square identity matrix of specified size. | |
double | trace (const Matrix &_inMatrix) |
Calculates the trace of matrix (sum of elements along diagonal). | |
double | norm2 (const Vector &_inVector) |
Calculates the 2-norm of the vector (square-root of the sum of the squares). | |
void | normalize (Vector &_inVector) |
Normalizes a vector. | |
double | normInf (const Vector &_inVector) |
Calculates the Infinity-norm of the vector (largest value of the components). | |
Matrix | skew (const Vector &_inVector) |
Calculates the skew-symmetric matrix of a vector. | |
Vector | crossP (const Vector &_v1, const Vector &_v2) |
Calculates the cross product of 2 vectors. | |
DirectionCosineMatrix | R1 (const Angle &_Angle) |
Calculates the principal rotation of the angle about the 1-axis. DirectionCosineMatrix. | |
DirectionCosineMatrix | R2 (const Angle &_Angle) |
Calculates the principal rotation of the angle about the 2-axis. DirectionCosineMatrix. | |
DirectionCosineMatrix | R3 (const Angle &_Angle) |
Calculates the principal rotation of the angle about the 3-axis. DirectionCosineMatrix. | |
double | DMS2Deg (const double &_Degrees, const double &_Minutes, const double &_Seconds) |
Converts an angle from Degrees, Minutes, Seconds (^o,','') to a single quantity in degrees and fractions of a degree. | |
void | Deg2DMS (const double &_Angle, double &Degrees, double &Minutes, double &Seconds) |
Converts an angle from a single quantity in degrees and fractions of a degree to Degrees, Minutes, Seconds (^o,',''). | |
Angle | DMS2Rad (const double &_Degrees, const double &_Minutes, const double &_Seconds) |
Converts an angle from Degrees, Minutes, Seconds (^o,','') to radians. | |
Angle | Deg2Rad (const Angle &_Degrees) |
Converts an angle from Degrees to radians. | |
void | Rad2DMS (const Angle &_Radians, double &Degrees, double &Minutes, double &Seconds) |
Converts an angle from radians to degrees, minutes, second format. | |
Angle | Rad2Deg (const Angle &_Radians) |
Converts an angle from radians to degrees. | |
Angle | atanh (const double &_z) |
void | Plot2D (const Matrix &_data) |
Use GnuPlot to plot the data in a matrix. | |
void | Plot3D (const Matrix &_data) |
void | DayofYear2YMD (int _dayOfYear, int _year, int &_month, int &_day) |
std::ostream & | operator<< (std::ostream &s, ssfTime &t) |
void | tick () |
Variables | |
const double | GRAVITATIONAL_CONSTANT = 6.669 * pow(10.0,-11.0) |
const double | deg2rad = (float)PI / 180.0 |
const int | MatrixIndexBase = 1 |
const int | VectorIndexBase = 1 |
const int | MatrixRowsIndex = 1 |
const int | MatrixColsIndex = 2 |
const int | SEMIMAJOR_AXIS = VectorIndexBase + 0 |
const int | ECCENTRICITY = VectorIndexBase + 1 |
const int | INCLINATION = VectorIndexBase + 2 |
const int | LONG_ASC_NODE = VectorIndexBase + 3 |
const int | ARG_PERIGEE = VectorIndexBase + 4 |
const int | TRUE_ANOMALY = VectorIndexBase + 5 |
const int | ECCENTRIC_ANOMALY = VectorIndexBase + 0 |
const int | ECCENTRIC_ANOMALY_0 = VectorIndexBase + 1 |
const int | MEAN_ANOMALY = VectorIndexBase + 2 |
const int | MEAN_ANOMALY_0 = VectorIndexBase + 3 |
const int | ARG_LATTITUDE = VectorIndexBase + 4 |
const int | LONG_PERIGEE = VectorIndexBase + 5 |
const int | TRUE_LONGITUDE = VectorIndexBase + 6 |
const int | QUATERNION_SIZE = 4 |
Number of elements in a quaternion vector. | |
const int | MRP_SIZE = 3 |
Number of elements in a MRP vector. | |
const int | DCM_SIZE = 3 |
Number of elements in a DCM row or column. | |
const int | EULERAXIS_SIZE = 3 |
Number of elements in an euler axis. | |
const int | EULERANGLES_SIZE = 3 |
Number of elements in an euler angle sequence. | |
int | DaysInMonth [12] = {31, 28, 31, 30, 31, 30, 31, 31, 30, 31, 30, 31} |
const ssfTime | c_GreenwichSiderealEpochTime = ssfTime(1970,1,1,0,0,0) |
time used as epoch for measuring Greenwich sidereal time. | |
const Angle | c_GreenwichSiderealTimeAtEpoch = 1.74933340 |
ssfTime | tickTime (-1) |
Initializes the tick/tock counter. | |
ssfTime | tockTime (-1) |
|
Definition at line 20 of file AttitudeState.h. Referenced by O_SESSAME::AttitudeState::GetAttitudeFrame(). |
|
specification of the parameter list type to be used for environmental function pointers Definition at line 45 of file Environment.h. |
|
|
defines a pointer to a Environmental disturbance calculating function Definition at line 47 of file Environment.h. |
|
|
Calculates the cross product of 2 vectors. Equation: /f$ v_3 = v_1 v_2 = v_1/f$
Definition at line 149 of file Matrix.h. References skew(), and Vector. Referenced by OrbitController::cals(), triadObserver::GetAttitude(), O_SESSAME::ModifiedRodriguezParameters::operator+(), O_SESSAME::ModifiedRodriguezParameters::operator-(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
Definition at line 46 of file Time.cpp. References DaysInMonth. |
|
Creates an square identity matrix of specified size.
Definition at line 56 of file Matrix.h. References Matrix, and CAMmatrixBase::setToValue(). Referenced by ab_Fmatrix(), ab_Hmatrix(), ab_Qmatrix(), ab_Rmatrix(), ab_stateRHSFunc(), AttituteDynamics(), ChangeAttitude(), ControlTorques(), O_SESSAME::DirectionCosineMatrix::DirectionCosineMatrix(), OrbitFrameIJK::GetRotation2IJK(), OrbitFrameIJK::GetRotationFromIJK(), atterrbiasObserver::Initialize(), LKFCovarianceMatrixPropagator(), LKFCovarianceMeasurementUpdate(), LKFStatePropagator(), main(), AttitudeModels::MRPKinematic(), otimes(), qdot(), QuaternionKinematics(), slidingModeControlMRPMW::Run(), O_SESSAME::DirectionCosineMatrix::Set(), SetupAttitude(), QuaternionEKFObserver::SingleMeasurement(), state_Euler_Hmatrix(), state_Euler_Qmatrix(), and state_Euler_Rmatrix(). |
|
|
Normalizes a vector.
Definition at line 94 of file Matrix.h. References norm2(). Referenced by triadObserver::GetAttitude(), O_SESSAME::Quaternion::Normalize(), triadObserver::Parse(), QuaternionEKFObserver::Parse(), and QuaternionEKFObserver::StateCovarianceUpdate(). |
|
Calculates the Infinity-norm of the vector (largest value of the components).
Definition at line 105 of file Matrix.h. References CAMvectorBase::maxAbs(). Referenced by O_SESSAME::Quaternion::Set(). |
|
Definition at line 150 of file Time.cpp. References O_SESSAME::ssfTime::GetSeconds(), and TIME_PRECISION. |
|
Use GnuPlot to plot the data in a matrix.
Definition at line 51 of file Plot.h. References Matrix, and MatrixIndexBase. |
|
Definition at line 78 of file Plot.h. References Matrix. |
|
Calculates the skew-symmetric matrix of a vector. Equation: /f[ {v^{}} = {bmatrix} 0 & -v_3 & v_2\ v_3 & 0 & -v_1\ -v_2 & v_1 & 0 {bmatrix} /f]
Definition at line 124 of file Matrix.h. References Matrix, MatrixIndexBase, CAMmatrixBase::setToValue(), and VectorIndexBase. Referenced by ab_Fmatrix(), ab_Hmatrix(), ab_measurementRHSFunc(), ab_stateRHSFunc(), Observer::AccelerationCorrection(), Att_Fmatrix(), Att_stateRHSFunc(), AttituteDynamics(), AttituteDynamics_QuaternionAngVel(), ControlTorques(), crossP(), Euler_Fmatrix(), Euler_stateRHSFunc(), O_SESSAME::OrbitState::GetOrbitAngularMomentum(), GravityGradientTorque(), QuaternionEKFObserver::MeasurementUpdate(), AttitudeModels::MRPKinematic(), otimes(), qdot(), QuaternionDynamics(), AttitudeModels::QuaternionKinematic(), QuaternionKinematics(), slidingModeControlMRPMW::Run(), SingleAxisController::Run(), MWCMGController::Run(), MRPTracking::Run(), DefaultController::Run(), AngularRateController::Run(), QuaternionEKFObserver::SingleMeasurement(), state_Euler_Fmatrix(), state_Euler_stateRHSFunc(), QuaternionEKFObserver::StateCovarianceUpdate(), and QuaternionEKFObserver::StateTransitionMatrix(). |
|
Definition at line 442 of file Time.h. References O_SESSAME::ssfTime::Set(), and tickTime. Referenced by main(), and Propagate(). |
|
Calculates the trace of matrix (sum of elements along diagonal).
Definition at line 69 of file Matrix.h. Referenced by O_SESSAME::DirectionCosineMatrix::GetEulerAxisAngle(), and O_SESSAME::Quaternion::Set(). |
|
Returns the absolute value of a vector.
Definition at line 34 of file Matrix.h. References CAMvectorBase::getIndexCount(), and Vector. Referenced by slidingModeControlMRPMW::Run(). |
|
position of the Argument of Latitude, Definition at line 49 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetArgLattitude(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationTrueAnomaly(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
position of the argument of perigee, Definition at line 41 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetArgLattitude(), O_SESSAME::Keplerian::GetArgPerigee(), O_SESSAME::Keplerian::GetLongPerigee(), O_SESSAME::Keplerian::GetTrueLongitude(), O_SESSAME::Keplerian::ReadTwoLineElementSet(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
time used as epoch for measuring Greenwich sidereal time.
|
|
actual Greenwich sidereal time at the specified epoch, m_GreenwichSiderealEpochTime. |
|
Definition at line 17 of file Time.cpp. Referenced by DayofYear2YMD(). |
|
Earth Radius [-] Definition at line 26 of file EarthCentralBody.h. |
|
position of the Eccentric Anomaly, Definition at line 45 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetEccentricAnomaly(), O_SESSAME::Keplerian::GetEccentricAnomalyFromTrueAnomaly(), O_SESSAME::Keplerian::GetMeanAnomalyFromEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationTrueAnomaly(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
position of the Initial Eccentric Anomaly, Definition at line 46 of file Keplerian.h. |
|
position of the eccentricity, Definition at line 38 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetEccentricAnomalyFromMeanAnomaly(), O_SESSAME::Keplerian::GetEccentricAnomalyFromTrueAnomaly(), O_SESSAME::Keplerian::GetEccentricity(), O_SESSAME::Keplerian::GetMeanAnomalyFromEccentricAnomaly(), O_SESSAME::Keplerian::GetTrueAnomalyFromEccentricAnomaly(), O_SESSAME::Keplerian::ReadTwoLineElementSet(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
Earth Radius [/f$m^3/kg-s^2/f$] Definition at line 24 of file EarthCentralBody.h. |
|
position of the inclination, Definition at line 39 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetInclination(), O_SESSAME::Keplerian::ReadTwoLineElementSet(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
position of the longitude of the ascending node, Definition at line 40 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetLongAscNode(), O_SESSAME::Keplerian::GetLongPerigee(), O_SESSAME::Keplerian::GetTrueLongitude(), O_SESSAME::Keplerian::ReadTwoLineElementSet(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
position of the Longitude of Perigee, Definition at line 50 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetLongPerigee(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationTrueAnomaly(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
< Value referring to the "columns" index Definition at line 27 of file Matrix.h. Referenced by O_SESSAME::LinearInterpolator::LinearInterpolator(), myOrbitStateConvFunc(), PositionVelocityConvFunc(), O_SESSAME::CombinedNumericPropagator::PropagateAttitude(), and O_SESSAME::CombinedNumericPropagator::PropagateOrbit(). |
|
< Beginning index of Matrix class Definition at line 24 of file Matrix.h. Referenced by O_SESSAME::Plot::AddPlot(), AttituteDynamics(), O_SESSAME::DirectionCosineMatrix::GetEulerAxisAngle(), SequentialFilterHistory::GetHistory(), O_SESSAME::OrbitHistory::GetHistory(), O_SESSAME::History::GetHistory(), O_SESSAME::AttitudeHistory::GetHistory(), IteratedExtendedKalmanFilterHistory::GetIterationHistory(), KalmanFilterHistory::GetKalmanHistory(), O_SESSAME::RungeKuttaIntegrator::Integrate(), main(), myOrbitStateConvFunc(), O_SESSAME::DirectionCosineMatrix::Normalize(), O_SESSAME::Quaternion::operator+(), O_SESSAME::Quaternion::operator-(), Plot(), Plot2D(), PositionVelocityConvFunc(), O_SESSAME::CombinedNumericPropagator::PropagateAttitude(), O_SESSAME::CombinedNumericPropagator::PropagateOrbit(), QuaternionDynamics(), QuaternionKinematics(), R1(), R2(), R3(), O_SESSAME::Quaternion::Set(), O_SESSAME::DirectionCosineMatrix::Set(), and skew(). |
|
< Value referring to the "rows" index |
|
position of the Mean Anomaly, Definition at line 47 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetMeanAnomaly(), O_SESSAME::Keplerian::GetMeanAnomalyFromEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationTrueAnomaly(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
position of the Initial Mean Anomaly, Definition at line 48 of file Keplerian.h. |
|
position of the Semimajor axis, Definition at line 37 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetSemimajorAxis(), O_SESSAME::Keplerian::GetTrueAnomalyFromEccentricAnomaly(), O_SESSAME::Keplerian::ReadTwoLineElementSet(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
|
|
position of the true anomaly, Definition at line 42 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetArgLattitude(), O_SESSAME::Keplerian::GetEccentricAnomalyFromTrueAnomaly(), O_SESSAME::Keplerian::GetTrueAnomaly(), O_SESSAME::Keplerian::GetTrueAnomalyFromEccentricAnomaly(), O_SESSAME::Keplerian::GetTrueLongitude(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
position of the True Longitude, Definition at line 51 of file Keplerian.h. Referenced by O_SESSAME::Keplerian::GetTrueLongitude(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationTrueAnomaly(), and O_SESSAME::Keplerian::SetPositionVelocity(). |
|
< Beginning index of Vector class Definition at line 25 of file Matrix.h. Referenced by AttituteDynamics(), AttituteDynamics_QuaternionAngVel(), ChangeOrbit(), DragForceFunction(), O_SESSAME::Quaternion::GetEulerAxisAngle(), O_SESSAME::DirectionCosineMatrix::GetEulerAxisAngle(), O_SESSAME::Keplerian::GetPositionVelocity(), O_SESSAME::Keplerian::GetPositionVelocityPQW(), O_SESSAME::Rotation::GetRotation(), O_SESSAME::PositionVelocity::GetState(), O_SESSAME::AttitudeState::GetState(), GravityForceFunction(), Whorl::Initialize(), O_SESSAME::LinearInterpolator::Interpolate(), main(), O_SESSAME::OsculatingOrbitalElements::Mapping(), O_SESSAME::Quaternion::operator+(), O_SESSAME::Quaternion::operator-(), OrbitForcesFunctor(), OrbitForcesWithDragFunctor(), O_SESSAME::Quaternion::Quaternion(), QuaternionKinematics(), O_SESSAME::Quaternion::Set(), O_SESSAME::ModifiedRodriguezParameters::Set(), O_SESSAME::DirectionCosineMatrix::Set(), O_SESSAME::Keplerian::SetKeplerianRepresentationEccentricAnomaly(), O_SESSAME::Keplerian::SetKeplerianRepresentationMeanAnomaly(), O_SESSAME::Keplerian::SetPositionVelocity(), O_SESSAME::PositionVelocity::SetState(), SetupOrbit(), skew(), ThirdBodyForceDisturbance(), and TwoBodyDynamics(). |