Package | Description |
---|---|
agi.foundation |
Contains commonly used types.
|
agi.foundation.access |
Contains types used in performing access calculations.
|
agi.foundation.aircraftpropagation |
Contains types for propagating an aircraft through various maneuvers subject to
flight phase performance models and wind effects.
|
agi.foundation.celestial |
Contains types used in modeling characteristics of celestial objects and celestial phenomena.
|
agi.foundation.communications.antennas |
Contains types for representing antennas, defining gain patterns, and processing electromagnetic signals.
|
agi.foundation.communications.signalprocessing |
Contains types for representing communication hardware and processing electromagnetic signals.
|
agi.foundation.coordinates |
Contains types for quantifying and converting between various coordinate representations.
|
agi.foundation.geometry |
Contains types for expressing the motion of fundamental geometric objects such as points, axes, and reference frames;
the manner in which they are related; and transformations between representations.
|
agi.foundation.geometry.shapes |
Contains types for representing geometric shapes such as curves, surfaces, and solids.
|
agi.foundation.infrastructure |
Contains types which support various aspects of the DME Component Libraries infrastructure.
|
agi.foundation.numericalmethods |
Contains general numerical algorithms.
|
agi.foundation.numericalmethods.advanced |
Contains additional advanced numerical algorithms and supporting types.
|
agi.foundation.propagators |
Contains types used in producing the state of an object from a known element set.
|
agi.foundation.propagators.advanced |
Contains types used to create more specialized propagation scenarios.
|
agi.foundation.routedesign |
Contains types for creating simple routes by specifying procedures at points of interest, how to connect them, and what height and speed to use along the route.
|
agi.foundation.routedesign.advanced |
Contains types used to define immutable geometry and configuration for routes.
|
agi.foundation.segmentpropagation |
Contains types for modeling a trajectory in segments, where the type of propagation varies for each segment.
|
Modifier and Type | Method and Description |
---|---|
abstract Motion1<T> |
MotionEvaluator1.evaluate(JulianDate date,
int order)
Evaluates the function.
|
abstract Motion1<TDependent> |
Function2.evaluate(TIndependent x,
int order)
Evaluates the function.
|
Modifier and Type | Method and Description |
---|---|
List<Motion1<T>> |
ImmutableDateMotionCollection1.getMotions()
Gets the list of motion instances in this collection.
|
List<Motion1<T>> |
IDateMotionCollection1.getMotions()
Gets the list of motion instances in this collection.
|
List<Motion1<T>> |
DateMotionCollection1.getMotions()
Gets the list of motion instances in this collection.
|
Modifier and Type | Method and Description |
---|---|
void |
IDateMotionCollection1.add(JulianDate date,
Motion1<T> motion)
Adds an item to the collection.
|
void |
DateMotionCollection1.add(JulianDate date,
Motion1<T> motion)
Adds an item to the collection.
|
static <T> boolean |
Motion1.equals(Motion1<T> left,
Motion1<T> right)
Returns
true if the two instances are exactly equal. |
static <T> boolean |
Motion1.equals(Motion1<T> left,
Motion1<T> right)
Returns
true if the two instances are exactly equal. |
boolean |
Motion1.equalsType(Motion1<T> other)
Indicates whether another instance of this type is exactly equal to this instance.
|
void |
DateMotionCollection1.insertItem(int index,
JulianDate date,
Motion1<T> motion)
Inserts an item at a particular index.
|
static <T> boolean |
Motion1.notEquals(Motion1<T> left,
Motion1<T> right)
Returns
true if the two instances are not exactly equal. |
static <T> boolean |
Motion1.notEquals(Motion1<T> left,
Motion1<T> right)
Returns
true if the two instances are not exactly equal. |
void |
IDateMotionCollection1.setItem(int index,
JulianDate date,
Motion1<T> motion)
Sets an item at a particular index.
|
void |
DateMotionCollection1.setItem(int index,
JulianDate date,
Motion1<T> motion)
Sets an item at a particular index.
|
Modifier and Type | Method and Description |
---|---|
static JulianDate |
AccessConstraintSampling.getNextStepFromRelativeMotion(JulianDate epoch,
Motion1<Cartesian> relativeMotion,
double maximumAngularMotion)
Computes an appropriate next sample step based on the relative motion between the two
platforms involved in the Access computation and a maximum relative motion per step.
|
Modifier and Type | Method and Description |
---|---|
Motion1<Cartesian> |
AircraftStateElementConverter.convertState(double[] overallState)
Convert the raw state into a
Cartesian and its derivatives. |
Motion1<double[]> |
AircraftStateElementConverter.getElementFromState(double[] overallState)
Produces this state element's values and their derivatives from the overall raw state.
|
Motion1<Cartesian> |
AircraftReferenceState.toMotionInFixedFrame(WindModel winds)
|
Modifier and Type | Method and Description |
---|---|
boolean |
AircraftStateElementConverter.adjustStateFromElement(double[] overallRawState,
Motion1<double[]> stateElementValues)
Adjust the subset of the overall raw state corresponding to this element to new values.
|
<T> boolean |
AircraftStateElementConverter.adjustStateWithType(double[] overallRawState,
Motion1<T> newStateElement)
Adjust the subset of the raw state corresponding to this element to new values.
|
static void |
AircraftMotionIntegrationPoint.configureIndicesOnEvaluator(EvaluatorGroup group,
AircraftMotionIntegrationPoint point,
Motion1<int[]> stateInputIndices)
This is called by
PropagationStateElement instances using PointPropagationParameter so that
the element can update the indices used to identify the individual values corresponding to this point in the state
during evaluation. |
Constructor and Description |
---|
AircraftStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Cartesian initialPosition,
Cartesian initialVelocity,
Ellipsoid ellipsoid)
Initializes a new instance.
|
AircraftStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Cartesian initialPosition,
Cartesian initialVelocity,
Ellipsoid ellipsoid,
Motion1<double[]> weights)
Initializes a new instance.
|
AircraftStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Cartesian initialPosition,
Cartesian initialVelocity,
Ellipsoid ellipsoid,
Motion1<double[]> weights)
Initializes a new instance.
|
Modifier and Type | Method and Description |
---|---|
static boolean |
CentralBodyIntersection.doesIntersect(Motion1<Cartesian> motionOne,
Motion1<Cartesian> motionTwo,
int numberOfRevs,
double geocentricRadiusOfIntersection,
double gravitationalParameter)
Determines if an orbit will intersect the planet specified by the corresponding gravitational parameter and geocentric radius of intersection.
|
static boolean |
CentralBodyIntersection.doesIntersect(Motion1<Cartesian> motionOne,
Motion1<Cartesian> motionTwo,
int numberOfRevs,
double geocentricRadiusOfIntersection,
double gravitationalParameter)
Determines if an orbit will intersect the planet specified by the corresponding gravitational parameter and geocentric radius of intersection.
|
Modifier and Type | Method and Description |
---|---|
Motion1<Double> |
SphericalTabularGainData.evaluate(Cartesian direction,
int order)
Evaluate the gain given the cartesian direction expressed in the antennas axes.
|
Modifier and Type | Method and Description |
---|---|
Motion1<Double> |
VariableGainAmplifierBackoffPolynomial.evaluate(Double x,
int order)
Evaluate the backoff polynomial given the normalized input power.
|
Modifier and Type | Method and Description |
---|---|
static Motion1<LongitudeLatitudeRadius> |
LongitudeLatitudeRadius.convertMotion(Motion1<Cartesian> motion,
int order)
Converts the motion given in terms of a set of
Cartesian coordinates to motion
of the corresponding set of LongitudeLatitudeRadius coordinates. |
static Motion1<AzimuthElevationRange> |
AzimuthElevationRange.convertMotion(Motion1<Cartesian> topographic,
int order)
Construct a Motion<Cartesian> which represents the motion
expressed with
AzimuthElevationRange values and derivatives. |
static Motion1<Cartesian> |
Cartesian.convertMotion(Motion1<LongitudeLatitudeRadius> motion,
int order)
Converts the motion given in terms of a set of
LongitudeLatitudeRadius coordinates to motion
of the corresponding set of Cartesian coordinates. |
static Motion1<Double> |
UnitCartesian.dihedralAngle(Motion2<UnitCartesian,Cartesian> motFrom,
Motion2<UnitCartesian,Cartesian> motTo,
Motion2<UnitCartesian,Cartesian> motAxis,
int order)
Calculates the scalar dihedral angle (and derivatives) of the three given values with
Cartesian derivative information.
|
<T> Motion1<T> |
ITimeBasedState.getMotion(String elementIdentification)
Returns the
Motion1 of the requested elementIdentification . |
<T> Motion1<T> |
BasicState.getMotion(String elementIdentification)
Returns the
Motion1 of the requested elementIdentification . |
Motion1<Cartesian> |
KinematicTransformation.getTranslationalMotion()
Gets the translational portion of this transformation.
|
Motion1<Cartesian> |
ModifiedKeplerianElements.toCartesian()
Returns a cartesian representation of these orbital elements.
|
Motion1<Cartesian> |
KozaiIzsakMeanElements.toCartesian()
Returns an osculating
Cartesian representation of these mean orbital elements. |
Motion1<Cartesian> |
KeplerianElements.toCartesian()
Returns a cartesian representation of these orbital elements.
|
Motion1<Cartesian> |
EquinoctialElements.toCartesian()
Converts this set of equinoctial elements to a cartesian position and velocity.
|
Motion1<Cartesian> |
DelaunayElements.toCartesian()
Converts this set of Delaunay elements to a cartesian position and velocity.
|
static Motion1<RotationVectorAngularVelocity> |
RotationVectorAngularVelocity.toMotionRotationVectorAngularVelocity(Motion2<UnitQuaternion,Cartesian> motionUnitQuaternionCartesian,
int order)
|
Motion1<Cartesian> |
HelmertTransformation.transform(Motion1<Cartesian> motion)
Transforms the motion observed in the A frame to the B frame.
|
Motion1<Cartesian> |
KinematicTransformation.transform(Motion1<Cartesian> motion)
Transforms the motion observed in the A frame to the B frame.
|
Motion1<Cartesian> |
HelmertTransformation.transform(Motion1<Cartesian> motion,
int order)
Transforms the motion observed in the A frame to the B frame.
|
Motion1<Cartesian> |
KinematicTransformation.transform(Motion1<Cartesian> motion,
int order)
Transforms the motion observed in the A frame to the B frame.
|
static Motion1<Cartesian> |
RotationalTransformation.transform(Motion2<UnitQuaternion,Cartesian> rotationalTransformation,
Motion1<Cartesian> motion,
int order)
Transforms the vector observed in the A axes to the B axes.
|
Modifier and Type | Method and Description |
---|---|
<T> void |
IAdjustableState.addStateElementMotion(String elementIdentification,
Motion1<T> motion)
Adds a Motion{T} element to this state.
|
<T> void |
BasicState.addStateElementMotion(String elementIdentification,
Motion1<T> motion)
Adds a Motion{T} element to this state.
|
static Motion2<UnitCartesian,Cartesian> |
UnitCartesian.convertMotion(Motion1<Cartesian> motion,
int order)
Converts the motion given in terms of a set of
Cartesian coordinates to motion
of the corresponding set of UnitCartesian coordinates. |
static Motion1<LongitudeLatitudeRadius> |
LongitudeLatitudeRadius.convertMotion(Motion1<Cartesian> motion,
int order)
Converts the motion given in terms of a set of
Cartesian coordinates to motion
of the corresponding set of LongitudeLatitudeRadius coordinates. |
static Motion1<AzimuthElevationRange> |
AzimuthElevationRange.convertMotion(Motion1<Cartesian> topographic,
int order)
Construct a Motion<Cartesian> which represents the motion
expressed with
AzimuthElevationRange values and derivatives. |
static Motion1<Cartesian> |
Cartesian.convertMotion(Motion1<LongitudeLatitudeRadius> motion,
int order)
Converts the motion given in terms of a set of
LongitudeLatitudeRadius coordinates to motion
of the corresponding set of Cartesian coordinates. |
static Motion2<UnitQuaternion,Cartesian> |
AlignedConstrained.getMotion(Motion1<Cartesian> principal,
Motion1<Cartesian> reference,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static Motion2<UnitQuaternion,Cartesian> |
AlignedConstrained.getMotion(Motion1<Cartesian> principal,
Motion1<Cartesian> reference,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
<T> void |
ITimeBasedState.modifyMotion(String elementIdentification,
Motion1<T> newValue)
Modifies this instance of
ITimeBasedState with the Motion1 of the
specified elementIdentification updated. |
<T> void |
BasicState.modifyMotion(String elementIdentification,
Motion1<T> newValue)
Modifies this instance of
ITimeBasedState with the Motion1 of the
specified elementIdentification updated. |
static Motion2<UnitQuaternion,Cartesian> |
RotationVectorAngularVelocity.toMotionUnitQuaternionCartesian(Motion1<RotationVectorAngularVelocity> motionRotationVectorAngularVelocity,
int order)
|
Motion1<Cartesian> |
HelmertTransformation.transform(Motion1<Cartesian> motion)
Transforms the motion observed in the A frame to the B frame.
|
Motion1<Cartesian> |
KinematicTransformation.transform(Motion1<Cartesian> motion)
Transforms the motion observed in the A frame to the B frame.
|
Motion1<Cartesian> |
HelmertTransformation.transform(Motion1<Cartesian> motion,
int order)
Transforms the motion observed in the A frame to the B frame.
|
Motion1<Cartesian> |
KinematicTransformation.transform(Motion1<Cartesian> motion,
int order)
Transforms the motion observed in the A frame to the B frame.
|
static Motion1<Cartesian> |
RotationalTransformation.transform(Motion2<UnitQuaternion,Cartesian> rotationalTransformation,
Motion1<Cartesian> motion,
int order)
Transforms the vector observed in the A axes to the B axes.
|
Constructor and Description |
---|
DelaunayElements(Motion1<Cartesian> motion,
double gravitationalParameter)
Initializes a new instance from the specified cartesian motion and gravitational constant.
|
DelaunayElements(Motion1<Cartesian> motion,
double gravitationalParameter,
double eccentricityTolerance,
double inclinationTolerance)
Initializes a new instance from the specified cartesian motion and gravitational constant.
|
EquinoctialElements(Motion1<Cartesian> motion,
double gravitationalParameter)
Initializes a new instance from the specified cartesian motion and gravitational constant.
|
KeplerianElements(Motion1<Cartesian> motion,
double gravitationalParameter)
Initializes a new instance from the specified
Cartesian motion and gravitational parameter. |
KeplerianElements(Motion1<Cartesian> motion,
double gravitationalParameter,
double eccentricityTolerance,
double inclinationTolerance)
Initializes a new instance from the specified cartesian motion and gravitational constant.
|
KinematicTransformation(Motion1<Cartesian> translationalMotion,
Motion2<UnitQuaternion,Cartesian> rotationalMotion)
Initializes a new instance from the specified translational and rotational motion.
|
KozaiIzsakMeanElements(Motion1<Cartesian> motion,
double gravitationalParameter,
double j2UnnormalizedValue,
double referenceDistance)
Initializes a set of Kozai-Izsak mean elements from the specified
Cartesian motion. |
ModifiedKeplerianElements(Motion1<Cartesian> motion,
double gravitationalParameter)
Initializes a new instance from the specified
Cartesian motion and gravitational constant. |
ModifiedKeplerianElements(Motion1<Cartesian> motion,
double gravitationalParameter,
double eccentricityTolerance,
double inclinationTolerance)
Initializes a new instance from the specified
Cartesian motion and gravitational parameter. |
Modifier and Type | Method and Description |
---|---|
Motion1<Cartesian> |
InternationalTerrestrialReferenceFrameTransformer.getRotation()
|
Motion1<Double> |
InternationalTerrestrialReferenceFrameTransformer.getScaling()
|
Motion1<Cartesian> |
InternationalTerrestrialReferenceFrameTransformer.getTranslation()
|
Modifier and Type | Method and Description |
---|---|
static Motion2<UnitQuaternion,Cartesian> |
AxesEastNorthUp.computeFixedToEastNorthUpRotation(Ellipsoid shape,
Motion1<Cartesian> fixedReferencePoint,
int order)
Computes the rotation from the central body's fixed axes to a set of east-north-up axes based on
a specified reference point.
|
static Motion2<UnitQuaternion,Cartesian> |
AxesNorthEastDown.computeFixedToNorthEastDownRotation(Ellipsoid shape,
Motion1<Cartesian> fixedReferencePoint,
int order)
Computes the rotation from the central body's fixed axes to a set of north-east-down axes based on
a specified reference point.
|
static Motion2<UnitQuaternion,Cartesian> |
AxesAlignedConstrained.computeTransformation(Motion1<Cartesian> principal,
AxisIndicator principalAxis,
Motion1<Cartesian> reference,
AxisIndicator referenceAxis,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static Motion2<UnitQuaternion,Cartesian> |
AxesAlignedConstrained.computeTransformation(Motion1<Cartesian> principal,
AxisIndicator principalAxis,
Motion1<Cartesian> reference,
AxisIndicator referenceAxis,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static Motion2<UnitQuaternion,Cartesian> |
AxesAlignedConstrained.computeTransformation(Motion1<Cartesian> principal,
Motion1<Cartesian> reference,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static Motion2<UnitQuaternion,Cartesian> |
AxesAlignedConstrained.computeTransformation(Motion1<Cartesian> principal,
Motion1<Cartesian> reference,
int order)
Given a principal and reference vector expressed in the same set of axes, computes a transformation that
will take a vector expressed in that set of axes and expresses it in the aligned-constrained axes.
|
static void |
AxesPropagationParameter.configureIndicesOnEvaluator(EvaluatorGroup group,
AxesPropagationParameter axes,
Motion1<int[]> stateInputIndices)
This is called by
PropagationStateElement instances using AxesPropagationParameter so that
the element can update the indices used to identify the individual values corresponding to this axes in the state
during evaluation. |
static void |
DynamicMatrixPropagationParameter.configureIndicesOnEvaluator(EvaluatorGroup group,
DynamicMatrixPropagationParameter matrix,
Motion1<int[]> stateInputIndices)
This is called by
PropagationStateElement instances using DynamicMatrixPropagationParameter so that
the element can update the indices used to identify the individual values corresponding to this scalar in the state
during evaluation. |
static void |
PointPropagationParameter.configureIndicesOnEvaluator(EvaluatorGroup group,
PointPropagationParameter point,
Motion1<int[]> stateInputIndices)
This is called by
PropagationStateElement instances using PointPropagationParameter so that
the element can update the indices used to identify the individual values corresponding to this point in the state
during evaluation. |
static void |
VectorPropagationParameter.configureIndicesOnEvaluator(EvaluatorGroup group,
VectorPropagationParameter vector,
Motion1<int[]> stateInputIndices)
This is called by
PropagationStateElement instances using VectorPropagationParameter so that
the element can update the indices used to identify the individual values corresponding to this vector in the state
during evaluation. |
void |
InternationalTerrestrialReferenceFrameTransformer.setRotation(Motion1<Cartesian> value)
|
void |
InternationalTerrestrialReferenceFrameTransformer.setScaling(Motion1<Double> value)
|
void |
InternationalTerrestrialReferenceFrameTransformer.setTranslation(Motion1<Cartesian> value)
|
Constructor and Description |
---|
InternationalTerrestrialReferenceFrameTransformer(String from,
String to,
JulianDate epoch,
Motion1<Cartesian> translation,
Motion1<Double> scaling,
Motion1<Cartesian> rotation)
Initializes a new instance.
|
InternationalTerrestrialReferenceFrameTransformer(String from,
String to,
JulianDate epoch,
Motion1<Cartesian> translation,
Motion1<Double> scaling,
Motion1<Cartesian> rotation)
Initializes a new instance.
|
InternationalTerrestrialReferenceFrameTransformer(String from,
String to,
JulianDate epoch,
Motion1<Cartesian> translation,
Motion1<Double> scaling,
Motion1<Cartesian> rotation)
Initializes a new instance.
|
Modifier and Type | Method and Description |
---|---|
Motion1<Cartographic> |
Ellipsoid.cartesianToCartographic(Motion1<Cartesian> cartesianMotion,
int order)
Converts the motion given in terms of cartesian coordinates to motion in cartographic coordinates.
|
Motion1<Cartesian> |
Ellipsoid.cartographicToCartesian(Motion1<Cartographic> cartographicMotion,
int order)
Converts the motion given in terms of planetodetic cartographic coordinates to motion in cartesian coordinates.
|
Motion1<Double> |
EllipsoidGeodesic.headingMotion(Cartographic location,
double groundSpeed)
Provides the heading and rate of change of heading at a location on the geodesic.
|
Motion1<Cartesian> |
EllipsoidRhumbLine.surfaceMotion(double distance,
double groundSpeed,
double groundAcceleration)
Converts the motion given in terms of motion on the rhumb line curve to motion of the surface point.
|
Motion1<Cartesian> |
EllipsoidGeodesic.surfaceMotion(double distance,
double groundSpeed,
double groundAcceleration)
Converts the motion given in terms of motion on the geodesic curve to motion of the surface point.
|
Motion1<Cartesian> |
Ellipsoid.surfaceProjection(Motion1<Cartesian> motion,
int order)
Computes the projection of the cartesian motion onto the ellipsoid surface.
|
Motion1<Cartesian> |
Ellipsoid.surfaceProjectionCartographic(Motion1<Cartographic> cartographicMotion,
int order)
Computes the projection of the cartographic motion onto the ellipsoid surface.
|
Modifier and Type | Method and Description |
---|---|
Motion1<Cartographic> |
Ellipsoid.cartesianToCartographic(Motion1<Cartesian> cartesianMotion,
int order)
Converts the motion given in terms of cartesian coordinates to motion in cartographic coordinates.
|
Motion1<Cartesian> |
Ellipsoid.cartographicToCartesian(Motion1<Cartographic> cartographicMotion,
int order)
Converts the motion given in terms of planetodetic cartographic coordinates to motion in cartesian coordinates.
|
Motion2<UnitCartesian,Cartesian> |
Ellipsoid.surfaceNormalMotion(Motion1<Cartesian> surfaceMotion,
int order)
Converts the motion given in terms of a surface point to motion of the surface normal vector.
|
Motion1<Cartesian> |
Ellipsoid.surfaceProjection(Motion1<Cartesian> motion,
int order)
Computes the projection of the cartesian motion onto the ellipsoid surface.
|
Motion1<Cartesian> |
Ellipsoid.surfaceProjectionCartographic(Motion1<Cartographic> cartographicMotion,
int order)
Computes the projection of the cartographic motion onto the ellipsoid surface.
|
Modifier and Type | Method and Description |
---|---|
Motion1<TResult> |
ParameterizedMotionEvaluator.evaluate(JulianDate date,
int order)
Evaluates this parameterized evaluator.
|
Motion1<T> |
CachingMotionEvaluator1.evaluate(JulianDate date,
int order)
Evaluates the function, first checking for a cached result corresponding to
date
and order . |
Motion1<TResult> |
ParameterizedMotionEvaluator1.evaluate(JulianDate date,
int order,
TParameter1 parameter1)
Evaluates this parameterized evaluator.
|
Motion1<TResult> |
ParameterizedMotionEvaluator2.evaluate(JulianDate date,
int order,
TParameter1 parameter1,
TParameter2 parameter2)
Evaluates this parameterized evaluator.
|
Motion1<TResult> |
ParameterizedMotionEvaluator3.evaluate(JulianDate date,
int order,
TParameter1 parameter1,
TParameter2 parameter2,
TParameter3 parameter3)
Evaluates this parameterized evaluator.
|
Motion1<TResult> |
ParameterizedMotionEvaluator4.evaluate(JulianDate date,
int order,
TParameter1 parameter1,
TParameter2 parameter2,
TParameter3 parameter3,
TParameter4 parameter4)
Evaluates this parameterized evaluator.
|
Motion1<TResult> |
ParameterizedMotionEvaluator5.evaluate(JulianDate date,
int order,
TParameter1 parameter1,
TParameter2 parameter2,
TParameter3 parameter3,
TParameter4 parameter4,
TParameter5 parameter5)
Evaluates this parameterized evaluator.
|
Motion1<TResult> |
ParameterizedMotionEvaluator6.evaluate(JulianDate date,
int order,
TParameter1 parameter1,
TParameter2 parameter2,
TParameter3 parameter3,
TParameter4 parameter4,
TParameter5 parameter5,
TParameter6 parameter6)
Evaluates this parameterized evaluator.
|
Motion1<TResult> |
ParameterizedMotionEvaluator7.evaluate(JulianDate date,
int order,
TParameter1 parameter1,
TParameter2 parameter2,
TParameter3 parameter3,
TParameter4 parameter4,
TParameter5 parameter5,
TParameter6 parameter6,
TParameter7 parameter7)
Evaluates this parameterized evaluator.
|
Modifier and Type | Method and Description |
---|---|
Motion1<Double> |
RealValuedScalarFunctionAdapter.evaluate(T x,
int order)
Evaluates the function.
|
Modifier and Type | Method and Description |
---|---|
Motion1<Matrix> |
PartialDerivativesEvaluator.evaluate(JulianDate date,
int order)
PartialDerivativeEvaluators only calculate zeroth order values,
this method returns a Motion1 of order zero regardless of the requested order. |
Modifier and Type | Method and Description |
---|---|
<T> Motion1<T> |
PropagationStateConverter.convertState(String elementID,
double[] state)
Convert a given state and auxiliary values to useful data based on the given element.
|
Motion1<double[]> |
PropagationVector.getAdaptiveWeights()
Gets the weights to be applied to the scalar values when
computing the error which determines how to adapt the step size during integration.
|
Motion1<Double> |
PropagationScalar.getAdaptiveWeights()
Gets the weights to be applied to the scalar values when
computing the error which determines how to adapt the step size during integration.
|
Motion1<double[]> |
PropagationStateConverter.getElementFromState(String elementID,
double[] overallState)
Produces this state element's values and their derivatives from the overall raw state.
|
Motion1<Cartesian> |
BallisticTrajectoryInformation.getFinalConditionsFixed()
|
Motion1<Cartesian> |
BallisticTrajectoryInformation.getFinalConditionsInertial()
|
Motion1<Cartesian> |
LambertResult.getFinalPositionMotion()
Gets the final motion as computed by the
LambertOrbitSolver . |
Motion1<Cartesian> |
TwoBodyStateTransitionMatrixPropagator.getInitialConditions()
|
Motion1<Cartesian> |
TwoBodyPropagator.getInitialConditions()
Gets the orbital elements from which to propagate.
|
Motion1<Cartesian> |
BallisticTrajectoryInformation.getInitialConditionsFixed()
|
Motion1<Cartesian> |
BallisticTrajectoryInformation.getInitialConditionsInertial()
|
Motion1<Cartesian> |
SinglePointStoppablePropagatorDefinition.getInitialMotion()
Gets the optional initial position and velocity for this propagator.
|
Motion1<Cartesian> |
LambertResult.getInitialPositionMotion()
Gets the initial motion as computed by the
LambertOrbitSolver . |
Motion1<Cartesian> |
PropagationVector.getInitialState()
|
Motion1<Double> |
PropagationScalar.getInitialState()
|
<T> Motion1<T> |
NumericalPropagatorState.getMotion(String elementIdentification)
Gets the
Motion1 stored in this state specified by the elementIdentification . |
Motion1<double[]> |
NumericalPropagatorState.getMotionOfDoubleArray(String elementIdentification)
Gets the motion of the specified
elementIdentification as an array of doubles. |
Motion1<Cartesian> |
InitialOrbitSolverResults.getPosition1Motion()
Gets the motion for the first position in the orbit.
|
Motion1<Cartesian> |
InitialOrbitSolverResults.getPosition2Motion()
Gets the motion for the second position in the orbit.
|
Motion1<Cartesian> |
InitialOrbitSolverResults.getPosition3Motion()
Gets the motion for the third position in the orbit.
|
static Motion1<Cartesian> |
SimpleAscentPropagator.mixedFixedPositionAndInertialVelocityToMotionFixed(boolean isAtPole,
KinematicTransformation inertialToFixed,
Cartesian position,
double inertialSpeed,
double inertialFlightPathAngle,
double inertialAzimuth)
|
Motion1<Cartesian> |
InitialOrbitSolver.solve(Cartesian position1,
Cartesian position2,
Cartesian position3)
Solves the initial orbit determination problem using the Gibbs method.
|
Motion1<Cartesian> |
InitialOrbitSolver.solve(Cartesian position1,
Cartesian position2,
Cartesian position3,
JulianDate time1,
JulianDate time2,
JulianDate time3)
Solves the initial orbit determination problem using the Herrick-Gibbs method for closely spaced positions.
|
Modifier and Type | Method and Description |
---|---|
<T> boolean |
PropagationStateConverter.adjustState(String elementID,
double[] stateToAdjust,
Motion1<T> newStateValues)
Adjust a subset of the overall state to new values based on the requested element.
|
boolean |
PropagationStateConverter.adjustStateFromElement(String elementID,
double[] overallRawState,
Motion1<double[]> stateElementValues)
Adjust the subset of the overall raw state corresponding to this element to new values.
|
PropagationStateElementConverter |
PropagationNewtonianPoint.getConverter(EvaluatorGroup group,
Motion1<int[]> stateInputIndices)
Gets an instance of an output type which can convert the output of propagation
back into the native type of this state element.
|
PropagationStateElementConverter |
PropagationEulerianAxes.getConverter(EvaluatorGroup group,
Motion1<int[]> stateInputIndices)
Gets an instance of an output type which can convert the output of propagation
back into the native type of this state element.
|
PropagationStateElementConverter |
StateTransitionMatrix.getConverter(EvaluatorGroup group,
Motion1<int[]> stateInputIndices)
Gets an instance of an output type which can convert the output of propagation
back into the native type of this state element.
|
PropagationStateElementConverter |
PropagationVector.getConverter(EvaluatorGroup group,
Motion1<int[]> stateInputIndices)
Gets an instance of an output type which can convert the output of propagation
back into the native type of this state element.
|
PropagationStateElementConverter |
PropagationScalar.getConverter(EvaluatorGroup group,
Motion1<int[]> stateInputIndices)
Gets an instance of an output type which can convert the output of propagation
back into the native type of this state element.
|
protected abstract PointEvaluator |
SinglePointStoppablePropagator.initializePropagationPoint(JulianDate date,
Motion1<Cartesian> motion)
Creates the
PointEvaluator that will be sampled for propagation. |
<T> void |
NumericalPropagatorState.modifyMotion(String elementIdentification,
Motion1<T> newValue)
Modifies this instance of
ITimeBasedState with the Motion1 of the
specified elementIdentification updated. |
SinglePointStoppablePropagatorResults |
SinglePointStoppablePropagator.propagateUntilStop(JulianDate initialDate,
Motion1<Cartesian> initialState,
IntegrationSense direction,
ITrackCalculationProgress progressTracker)
Propagates a
Point forward in time from the initial conditions. |
SinglePointStoppablePropagatorResults |
SinglePointStoppablePropagator.propagateUntilStop(JulianDate initialDate,
Motion1<Cartesian> initialState,
Iterable<? extends StoppingConditionEvaluator> conditions,
IntegrationSense direction,
int outputSparsity,
ITrackCalculationProgress progressTracker)
Propagates a
Point forward in time from the initial conditions. |
void |
PropagationVector.setAdaptiveWeights(Motion1<double[]> value)
Sets the weights to be applied to the scalar values when
computing the error which determines how to adapt the step size during integration.
|
void |
PropagationScalar.setAdaptiveWeights(Motion1<Double> value)
Sets the weights to be applied to the scalar values when
computing the error which determines how to adapt the step size during integration.
|
void |
LambertResult.setFinalPositionMotion(Motion1<Cartesian> value)
Sets the final motion as computed by the
LambertOrbitSolver . |
void |
TwoBodyStateTransitionMatrixPropagator.setInitialConditions(Motion1<Cartesian> value)
|
void |
TwoBodyPropagator.setInitialConditions(Motion1<Cartesian> value)
Sets the orbital elements from which to propagate.
|
void |
SinglePointStoppablePropagatorDefinition.setInitialMotion(Motion1<Cartesian> value)
Sets the optional initial position and velocity for this propagator.
|
void |
LambertResult.setInitialPositionMotion(Motion1<Cartesian> value)
Sets the initial motion as computed by the
LambertOrbitSolver . |
void |
PropagationVector.setInitialState(Motion1<Cartesian> value)
|
void |
PropagationScalar.setInitialState(Motion1<Double> value)
|
Constructor and Description |
---|
InitialOrbitSolverResults(Motion1<Cartesian> position1Motion,
Motion1<Cartesian> position2Motion,
Motion1<Cartesian> position3Motion)
Initializes the results data container.
|
InitialOrbitSolverResults(Motion1<Cartesian> position1Motion,
Motion1<Cartesian> position2Motion,
Motion1<Cartesian> position3Motion)
Initializes the results data container.
|
InitialOrbitSolverResults(Motion1<Cartesian> position1Motion,
Motion1<Cartesian> position2Motion,
Motion1<Cartesian> position3Motion)
Initializes the results data container.
|
J2Propagator(JulianDate orbitEpoch,
ReferenceFrame referenceFrame,
Motion1<Cartesian> initialConditions,
double gravitationalParameter,
double j2UnnormalizedValue,
double referenceDistance)
Initializes a new instance.
|
J4Propagator(JulianDate orbitEpoch,
ReferenceFrame referenceFrame,
Motion1<Cartesian> initialConditions,
double gravitationalParameter,
double j2UnnormalizedValue,
double j4UnnormalizedValue,
double referenceDistance)
Initializes a new instance.
|
TwoBodyPropagator(JulianDate orbitEpoch,
ReferenceFrame referenceFrame,
Motion1<Cartesian> initialConditions,
double gravitationalParameter)
Initializes a new instance.
|
TwoBodyStateTransitionMatrixPropagator(JulianDate epoch,
Motion1<Cartesian> initialConditions,
double gravitationalParameter)
Initializes a new instance.
|
Modifier and Type | Method and Description |
---|---|
Motion1<RotationVectorAngularVelocity> |
RotationVectorAngularVelocityStateElementConverter.convertState(double[] overallState)
Convert the raw state into a
RotationVectorAngularVelocity
and its derivatives. |
Motion1<Matrix> |
MatrixStateElementConverter.convertState(double[] overallState)
Convert the raw state into a
Matrix
and its derivatives. |
Motion1<Cartesian> |
CartesianStateElementConverter.convertState(double[] overallState)
Convert the raw state into a
Cartesian
and its derivatives. |
abstract <T> Motion1<T> |
PropagationStateElementConverter.convertState(double[] overallState)
Convert the raw state into this instance's
TypeOfOutput (get )
and its derivatives. |
abstract <T> Motion1<T> |
AuxiliaryStateElementConverter.convertState(double[] auxiliaryState)
Convert the raw auxiliary state into this instance's
TypeOfOutput (get )
and its derivatives. |
Motion1<double[]> |
PropagationStateElementConverter.getAdaptiveWeights()
Gets the weights to be applied to the state elements when
computing the error which determines how to adapt the step size during integration.
|
Motion1<double[]> |
RotationVectorAngularVelocityStateElementConverter.getElementFromState(double[] overallState)
Produces this state element's values and their derivatives from the overall raw state.
|
abstract Motion1<double[]> |
PropagationStateElementConverter.getElementFromState(double[] overallState)
Produces this state element's values and their derivatives from the overall raw state.
|
Motion1<double[]> |
MatrixStateElementConverter.getElementFromState(double[] overallState)
Produces this state element's values and their derivatives from the overall raw state.
|
Motion1<double[]> |
CartesianStateElementConverter.getElementFromState(double[] overallState)
Produces this state element's values and their derivatives from the overall raw state.
|
Motion1<double[]> |
PropagationStateElementConverter.getInitialState()
Gets the initial values of this element of the state and their derivatives.
|
Motion1<int[]> |
PropagationStateElementConverter.getStateIndices()
Gets the indices locating each variable of this element within the overall state.
|
Modifier and Type | Method and Description |
---|---|
boolean |
RotationVectorAngularVelocityStateElementConverter.adjustStateFromElement(double[] overallRawState,
Motion1<double[]> stateElementValues)
Adjust the subset of the overall raw state corresponding to this element to new values.
|
abstract boolean |
PropagationStateElementConverter.adjustStateFromElement(double[] overallRawState,
Motion1<double[]> stateElementValues)
Adjust the subset of the overall raw state corresponding to this element to new values.
|
boolean |
MatrixStateElementConverter.adjustStateFromElement(double[] overallRawState,
Motion1<double[]> stateElementValues)
Adjust the subset of the overall raw state corresponding to this element to new values.
|
boolean |
CartesianStateElementConverter.adjustStateFromElement(double[] overallRawState,
Motion1<double[]> stateElementValues)
Adjust the subset of the overall raw state corresponding to this element to new values.
|
<T> boolean |
RotationVectorAngularVelocityStateElementConverter.adjustStateWithType(double[] overallRawState,
Motion1<T> newStateElement)
Adjust the subset of the raw state corresponding to this element to new values.
|
abstract <T> boolean |
PropagationStateElementConverter.adjustStateWithType(double[] overallRawState,
Motion1<T> newStateElement)
Adjust the subset of the raw state corresponding to this element to new values.
|
<T> boolean |
MatrixStateElementConverter.adjustStateWithType(double[] overallRawState,
Motion1<T> newStateElement)
Adjust the subset of the raw state corresponding to this element to new values.
|
<T> boolean |
CartesianStateElementConverter.adjustStateWithType(double[] overallRawState,
Motion1<T> newStateElement)
Adjust the subset of the raw state corresponding to this element to new values.
|
abstract PropagationStateElementConverter |
PropagationStateElement.getConverter(EvaluatorGroup group,
Motion1<int[]> stateInputIndices)
Gets an instance of an output type which can convert the output of propagation
back into the native type of this state element.
|
protected void |
PropagationStateElementConverter.setAdaptiveWeights(Motion1<double[]> value)
Sets the weights to be applied to the state elements when
computing the error which determines how to adapt the step size during integration.
|
Constructor and Description |
---|
CartesianStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Cartesian> initialState)
Initializes a new instance.
|
CartesianStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Cartesian> initialState)
Initializes a new instance.
|
CartesianStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Cartesian> initialState,
Motion1<double[]> weights)
Initializes a new instance.
|
CartesianStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Cartesian> initialState,
Motion1<double[]> weights)
Initializes a new instance.
|
CartesianStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Cartesian> initialState,
Motion1<double[]> weights)
Initializes a new instance.
|
MatrixStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Matrix> initialState)
Initializes a new instance.
|
MatrixStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Matrix> initialState)
Initializes a new instance.
|
MatrixStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Matrix> initialState,
Motion1<Matrix> weights)
Initializes a new instance.
|
MatrixStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Matrix> initialState,
Motion1<Matrix> weights)
Initializes a new instance.
|
MatrixStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<Matrix> initialState,
Motion1<Matrix> weights)
Initializes a new instance.
|
PropagationStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<double[]> initialState)
Initializes a new instance.
|
PropagationStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<double[]> initialState)
Initializes a new instance.
|
PropagationStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<double[]> initialState,
Motion1<double[]> weights)
Initializes a new instance.
|
PropagationStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<double[]> initialState,
Motion1<double[]> weights)
Initializes a new instance.
|
PropagationStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<double[]> initialState,
Motion1<double[]> weights)
Initializes a new instance.
|
RotationVectorAngularVelocityStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<RotationVectorAngularVelocity> initialState)
Initializes a new instance.
|
RotationVectorAngularVelocityStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<RotationVectorAngularVelocity> initialState)
Initializes a new instance.
|
RotationVectorAngularVelocityStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<RotationVectorAngularVelocity> initialState,
Motion1<double[]> weights)
Initializes a new instance.
|
RotationVectorAngularVelocityStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<RotationVectorAngularVelocity> initialState,
Motion1<double[]> weights)
Initializes a new instance.
|
RotationVectorAngularVelocityStateElementConverter(String identification,
Motion1<int[]> stateIndices,
Motion1<RotationVectorAngularVelocity> initialState,
Motion1<double[]> weights)
Initializes a new instance.
|
Modifier and Type | Method and Description |
---|---|
static HeadingAtWaypointProcedure |
HeadingAtWaypointProcedure.getFinalFromNextState(CentralBody centralBody,
Motion1<Cartesian> stateInFixedFrame,
ProfileDynamics dynamics,
double turningRadius)
Creates an instance of the procedure to represent a final state for a route
based on a given state (position and velocity) in the
FixedFrame (get / set ) of the CentralBody . |
static HeadingAtWaypointProcedure |
HeadingAtWaypointProcedure.getInitialFromPreviousState(CentralBody centralBody,
Motion1<Cartesian> stateInFixedFrame,
ProfileDynamics dynamics,
double turningRadius)
Creates an instance of the procedure to represent an initial state for a route
based on a given state (position and velocity) in the
FixedFrame (get / set ) of the CentralBody . |
Modifier and Type | Method and Description |
---|---|
Motion1<Double> |
ParametricRouteSegment.getHeading(Duration time,
int order)
Get the heading and rates at a given time since the start of the segment.
|
abstract Motion1<Double> |
SurfaceSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Motion1<Double> |
SurfaceCurveSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Motion1<Double> |
PartialSurfaceSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Motion1<Double> |
DegenerateSurfaceSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Motion1<Double> |
CompositeSurfaceSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Motion1<Double> |
StandardTransitionProfileSegment.getHeight(Duration time,
int order)
Get the value for the height above the
TerrainProvider height reference
specified by the StandardTransitionProfileSegment.getHeightReference(agi.foundation.time.Duration) method at the given time. |
abstract Motion1<Double> |
ProfileSegment.getHeight(Duration time,
int order)
Get the value for the height above the
TerrainProvider height reference
specified by the ProfileSegment.getHeightReference(agi.foundation.time.Duration) method at the given time. |
Motion1<Double> |
ConstantHeightSegment.getHeight(Duration time,
int order)
Get the value for the height above the
TerrainProvider height reference
specified by the ConstantHeightSegment.getHeightReference(agi.foundation.time.Duration) method at the given time. |
Motion1<Double> |
CompositeProfileSegment.getHeight(Duration time,
int order)
Get the value for the height above the
TerrainProvider height reference
specified by the CompositeProfileSegment.getHeightReference(agi.foundation.time.Duration) method at the given time. |
Motion1<Double> |
ParametricRouteSegment.getHeight(Duration time,
int order,
TerrainProvider heightReference)
Get the height and rates at a given time since the start of the segment.
|
Motion1<Double> |
StandardTransitionProfileSegment.getSurfaceMotion(Duration time,
int order)
Get the value for the arc length and its derivatives along the surface path, in meters and seconds.
|
abstract Motion1<Double> |
ProfileSegment.getSurfaceMotion(Duration time,
int order)
Get the value for the arc length and its derivatives along the surface path, in meters and seconds.
|
Motion1<Double> |
ConstantHeightSegment.getSurfaceMotion(Duration time,
int order)
Get the value for the arc length and its derivatives along the surface path, in meters and seconds.
|
Motion1<Double> |
CompositeProfileSegment.getSurfaceMotion(Duration time,
int order)
Get the value for the arc length and its derivatives along the surface path, in meters and seconds.
|
Motion1<Cartesian> |
ParametricRouteSegment.traverseFixed(Duration time,
int order)
Produces the position along the route in the fixed frame of the
SurfaceShape (get )
as a function of time from the start of this segment of the route. |
Modifier and Type | Method and Description |
---|---|
abstract Motion1<Double> |
SurfaceSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Motion1<Double> |
SurfaceCurveSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Motion1<Double> |
PartialSurfaceSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Motion1<Double> |
DegenerateSurfaceSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Motion1<Double> |
CompositeSurfaceSegment.getHeading(Motion1<Double> distanceAlongPath,
int order)
Get the heading and its derivatives, in radians and radians/meter.
|
Modifier and Type | Method and Description |
---|---|
<T> ArrayList<Motion1<T>> |
SegmentResults.getMotionCollection(String element)
|
static <T> ArrayList<Motion1<T>> |
SegmentResults.getMotionCollection(String element,
List<ITimeBasedState> states)
Gets a
List of the element . |