Package | Description |
---|---|
org.orekit.estimation.iod |
This package provides initial orbit determination methods.
|
org.orekit.estimation.leastsquares |
The leastsquares package provides an implementation of a batch least
squares estimator engine to perform an orbit determination.
|
org.orekit.forces.maneuvers |
This package provides models of simple maneuvers.
|
org.orekit.models.earth.tessellation |
This package provides ways to do tessellation and sampling of zones of
interest over an ellipsoid surface.
|
org.orekit.orbits |
This package provides classes to represent orbits.
|
org.orekit.propagation |
Propagation
|
org.orekit.propagation.analytical |
Top level package for analytical propagators.
|
org.orekit.propagation.analytical.gnss |
This package provides classes to propagate GNSS orbits.
|
org.orekit.propagation.analytical.tle |
This package provides classes to read and extrapolate tle's.
|
org.orekit.propagation.conversion |
This package provides tools to convert a given propagator or a set of
SpacecraftState into another propagator. |
org.orekit.propagation.events |
This package provides interfaces and classes dealing with events occurring during propagation.
|
org.orekit.propagation.integration |
Utilities for integration-based propagators (both numerical and semi-analytical).
|
org.orekit.propagation.numerical |
Top level package for numerical propagators.
|
org.orekit.propagation.semianalytical.dsst |
This package provides an implementation of the Draper Semi-analytical
Satellite Theory (DSST).
|
org.orekit.propagation.semianalytical.dsst.forces |
This package provides force models for Draper Semi-analytical Satellite Theory (DSST).
|
org.orekit.propagation.semianalytical.dsst.utilities |
This package provides utilities for Draper Semi-analytical Satellite Theory (DSST).
|
org.orekit.ssa.collision.shorttermencounter.probability.twod |
Package specific to calculus assuming a 2D short-term encounter model.
|
org.orekit.utils |
This package provides useful objects.
|
Modifier and Type | Method and Description |
---|---|
Orbit |
IodGauss.estimate(Frame outputFrame,
AngularAzEl azEl1,
AngularAzEl azEl2,
AngularAzEl azEl3)
Estimate and orbit based on Gauss Intial Orbit Determination method.
|
Orbit |
IodLaplace.estimate(Frame outputFrame,
AngularAzEl azEl1,
AngularAzEl azEl2,
AngularAzEl azEl3)
Estimate the orbit from three angular observations at the same location.
|
Orbit |
IodGooding.estimate(Frame outputFrame,
AngularAzEl azEl1,
AngularAzEl azEl2,
AngularAzEl azEl3,
double rho1init,
double rho3init)
Estimate orbit from three angular observations.
|
Orbit |
IodGooding.estimate(Frame outputFrame,
AngularAzEl azEl1,
AngularAzEl azEl2,
AngularAzEl azEl3,
double rho1init,
double rho3init,
int nRev,
boolean direction)
Estimate orbit from three angular observations.
|
Orbit |
IodGauss.estimate(Frame outputFrame,
AngularRaDec raDec1,
AngularRaDec raDec2,
AngularRaDec raDec3)
Estimate and orbit based on Gauss Intial Orbit Determination method.
|
Orbit |
IodLaplace.estimate(Frame outputFrame,
AngularRaDec raDec1,
AngularRaDec raDec2,
AngularRaDec raDec3)
Estimate the orbit from three angular observations at the same location.
|
Orbit |
IodGooding.estimate(Frame outputFrame,
AngularRaDec raDec1,
AngularRaDec raDec2,
AngularRaDec raDec3,
double rho1init,
double rho3init)
Estimate orbit from three angular observations.
|
Orbit |
IodGooding.estimate(Frame outputFrame,
AngularRaDec raDec1,
AngularRaDec raDec2,
AngularRaDec raDec3,
double rho1init,
double rho3init,
int nRev,
boolean direction)
Estimate orbit from three angular observations.
|
Orbit |
IodLambert.estimate(Frame frame,
boolean posigrade,
int nRev,
Position p1,
Position p2)
Estimate an initial orbit from two position measurements.
|
Orbit |
IodLambert.estimate(Frame frame,
boolean posigrade,
int nRev,
PV pv1,
PV pv2)
Estimate an initial orbit from two PV measurements.
|
Orbit |
IodLambert.estimate(Frame frame,
boolean posigrade,
int nRev,
org.hipparchus.geometry.euclidean.threed.Vector3D p1,
AbsoluteDate t1,
org.hipparchus.geometry.euclidean.threed.Vector3D p2,
AbsoluteDate t2)
Estimate a Keplerian orbit given two position vectors and a duration.
|
Orbit |
IodGibbs.estimate(Frame frame,
Position p1,
Position p2,
Position p3)
Give an initial orbit estimation, assuming Keplerian motion.
|
Orbit |
IodLaplace.estimate(Frame outputFrame,
PVCoordinates obsPva,
AbsoluteDate obsDate1,
org.hipparchus.geometry.euclidean.threed.Vector3D los1,
AbsoluteDate obsDate2,
org.hipparchus.geometry.euclidean.threed.Vector3D los2,
AbsoluteDate obsDate3,
org.hipparchus.geometry.euclidean.threed.Vector3D los3)
Estimate orbit from three line of sight angles at the same location.
|
Orbit |
IodGibbs.estimate(Frame frame,
PV pv1,
PV pv2,
PV pv3)
Give an initial orbit estimation, assuming Keplerian motion.
|
Orbit |
IodGibbs.estimate(Frame frame,
org.hipparchus.geometry.euclidean.threed.Vector3D r1,
AbsoluteDate date1,
org.hipparchus.geometry.euclidean.threed.Vector3D r2,
AbsoluteDate date2,
org.hipparchus.geometry.euclidean.threed.Vector3D r3,
AbsoluteDate date3)
Give an initial orbit estimation, assuming Keplerian motion.
|
Orbit |
IodGauss.estimate(Frame outputFrame,
org.hipparchus.geometry.euclidean.threed.Vector3D obsP1,
AbsoluteDate obsDate1,
org.hipparchus.geometry.euclidean.threed.Vector3D los1,
org.hipparchus.geometry.euclidean.threed.Vector3D obsP2,
AbsoluteDate obsDate2,
org.hipparchus.geometry.euclidean.threed.Vector3D los2,
org.hipparchus.geometry.euclidean.threed.Vector3D obsP3,
AbsoluteDate obsDate3,
org.hipparchus.geometry.euclidean.threed.Vector3D los3)
Estimate and orbit based on Gauss Intial Orbit Determination method.
|
Orbit |
IodGooding.estimate(Frame outputFrame,
org.hipparchus.geometry.euclidean.threed.Vector3D O1,
org.hipparchus.geometry.euclidean.threed.Vector3D O2,
org.hipparchus.geometry.euclidean.threed.Vector3D O3,
org.hipparchus.geometry.euclidean.threed.Vector3D lineOfSight1,
AbsoluteDate dateObs1,
org.hipparchus.geometry.euclidean.threed.Vector3D lineOfSight2,
AbsoluteDate dateObs2,
org.hipparchus.geometry.euclidean.threed.Vector3D lineOfSight3,
AbsoluteDate dateObs3,
double rho1init,
double rho3init)
Estimate orbit from three line of sight.
|
Orbit |
IodGooding.estimate(Frame outputFrame,
org.hipparchus.geometry.euclidean.threed.Vector3D O1,
org.hipparchus.geometry.euclidean.threed.Vector3D O2,
org.hipparchus.geometry.euclidean.threed.Vector3D O3,
org.hipparchus.geometry.euclidean.threed.Vector3D lineOfSight1,
AbsoluteDate dateObs1,
org.hipparchus.geometry.euclidean.threed.Vector3D lineOfSight2,
AbsoluteDate dateObs2,
org.hipparchus.geometry.euclidean.threed.Vector3D lineOfSight3,
AbsoluteDate dateObs3,
double rho1init,
double rho3init,
int nRev,
boolean direction)
Estimate orbit from three line of sight.
|
Modifier and Type | Method and Description |
---|---|
protected abstract Orbit |
AbstractBatchLSModel.configureOrbits(MatricesHarvester harvester,
Propagator propagator)
Configure the current estimated orbits.
|
protected Orbit |
BatchLSModel.configureOrbits(MatricesHarvester harvester,
Propagator propagator)
Configure the current estimated orbits.
|
protected Orbit |
DSSTBatchLSModel.configureOrbits(MatricesHarvester harvester,
Propagator propagator)
Configure the current estimated orbits.
|
Modifier and Type | Method and Description |
---|---|
void |
BatchLSObserver.evaluationPerformed(int iterationsCount,
int evaluationsCount,
Orbit[] orbits,
ParameterDriversList estimatedOrbitalParameters,
ParameterDriversList estimatedPropagatorParameters,
ParameterDriversList estimatedMeasurementsParameters,
EstimationsProvider evaluationsProvider,
org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation lspEvaluation)
Notification callback for the end of each evaluation.
|
void |
ModelObserver.modelCalled(Orbit[] orbits,
Map<ObservedMeasurement<?>,EstimatedMeasurement<?>> estimations)
Notification callback for orbit changes.
|
Modifier and Type | Method and Description |
---|---|
Orbit |
SmallManeuverAnalyticalModel.apply(Orbit orbit1)
Compute the effect of the maneuver on an orbit.
|
Modifier and Type | Method and Description |
---|---|
Orbit |
SmallManeuverAnalyticalModel.apply(Orbit orbit1)
Compute the effect of the maneuver on an orbit.
|
void |
SmallManeuverAnalyticalModel.getJacobian(Orbit orbit1,
PositionAngleType positionAngleType,
double[][] jacobian)
Compute the Jacobian of the orbit with respect to maneuver parameters.
|
Constructor and Description |
---|
AlongTrackAiming(OneAxisEllipsoid ellipsoid,
Orbit orbit,
boolean isAscending)
Simple constructor.
|
Modifier and Type | Class and Description |
---|---|
class |
CartesianOrbit
This class holds Cartesian orbital parameters.
|
class |
CircularOrbit
This class handles circular orbital parameters.
|
class |
EquinoctialOrbit
This class handles equinoctial orbital parameters, which can support both
circular and equatorial orbits.
|
class |
KeplerianOrbit
This class handles traditional Keplerian orbital parameters.
|
Modifier and Type | Method and Description |
---|---|
abstract Orbit |
OrbitType.convertType(Orbit orbit)
Convert an orbit to the instance type.
|
Orbit |
AbstractOrbitInterpolator.interpolate(AbsoluteDate interpolationDate,
Collection<Orbit> sample)
Get an interpolated instance.
|
protected Orbit |
OrbitBlender.interpolate(AbstractTimeInterpolator.InterpolationData interpolationData)
Interpolate instance from given interpolation data.
|
protected Orbit |
OrbitHermiteInterpolator.interpolate(AbstractTimeInterpolator.InterpolationData interpolationData)
Interpolate instance from given interpolation data.
|
abstract Orbit |
OrbitType.mapArrayToOrbit(double[] array,
double[] arrayDot,
PositionAngleType type,
AbsoluteDate date,
double mu,
Frame frame)
Convert state array to orbital parameters.
|
abstract Orbit |
OrbitType.normalize(Orbit orbit,
Orbit reference)
Normalize one orbit with respect to a reference one.
|
abstract Orbit |
Orbit.shiftedBy(double dt)
Get a time-shifted orbit.
|
abstract Orbit |
FieldOrbit.toOrbit()
Transforms the FieldOrbit instance into an Orbit instance.
|
Modifier and Type | Method and Description |
---|---|
abstract <T extends org.hipparchus.CalculusFieldElement<T>> |
OrbitType.convertToFieldOrbit(org.hipparchus.Field<T> field,
Orbit orbit)
Convert an orbit to the "Fielded" instance type.
|
abstract Orbit |
OrbitType.convertType(Orbit orbit)
Convert an orbit to the instance type.
|
abstract ParameterDriversList |
OrbitType.getDrivers(double dP,
Orbit orbit,
PositionAngleType type)
Get parameters drivers initialized from a reference orbit.
|
abstract void |
OrbitType.mapOrbitToArray(Orbit orbit,
PositionAngleType type,
double[] stateVector,
double[] stateVectorDot)
Convert orbit to state array.
|
abstract Orbit |
OrbitType.normalize(Orbit orbit,
Orbit reference)
Normalize one orbit with respect to a reference one.
|
protected double[] |
OrbitType.scale(double dP,
Orbit orbit)
Compute scaling factor for parameters drivers.
|
Modifier and Type | Method and Description |
---|---|
static void |
AbstractOrbitInterpolator.checkOrbitsConsistency(Collection<Orbit> sample)
Check orbits consistency by comparing their gravitational parameters ยต.
|
Orbit |
AbstractOrbitInterpolator.interpolate(AbsoluteDate interpolationDate,
Collection<Orbit> sample)
Get an interpolated instance.
|
Constructor and Description |
---|
CartesianOrbit(Orbit op)
Constructor from any kind of orbital parameters.
|
CircularOrbit(Orbit op)
Constructor from any kind of orbital parameters.
|
EquinoctialOrbit(Orbit op)
Constructor from any kind of orbital parameters.
|
FieldCartesianOrbit(org.hipparchus.Field<T> field,
Orbit op)
Constructor from Field and Orbit.
|
FieldCircularOrbit(org.hipparchus.Field<T> field,
Orbit op)
Constructor from Field and Orbit.
|
FieldEquinoctialOrbit(org.hipparchus.Field<T> field,
Orbit op)
Constructor from Field and Orbit.
|
FieldKeplerianOrbit(org.hipparchus.Field<T> field,
Orbit op)
Constructor from Field and Orbit.
|
KeplerianOrbit(Orbit op)
Constructor from any kind of orbital parameters.
|
Modifier and Type | Method and Description |
---|---|
Orbit |
SpacecraftState.getOrbit()
Get the current orbit.
|
protected Orbit |
AbstractStateCovarianceInterpolator.interpolateOrbit(AbsoluteDate interpolationDate,
List<TimeStampedPair<Orbit,StateCovariance>> neighborList)
Interpolate orbit at given interpolation date.
|
Modifier and Type | Method and Description |
---|---|
protected TimeStampedPair<Orbit,StateCovariance> |
AbstractStateCovarianceInterpolator.expressCovarianceInDesiredOutput(Orbit interpolatedOrbit,
StateCovariance covarianceInOrbitFrame)
Express covariance in output configuration defined at this instance construction.
|
Optional<TimeInterpolator<Orbit>> |
SpacecraftStateInterpolator.getOrbitInterpolator()
Get orbit interpolator.
|
TimeInterpolator<Orbit> |
AbstractStateCovarianceInterpolator.getOrbitInterpolator()
Get orbit interpolator.
|
TimeStampedPair<Orbit,StateCovariance> |
AbstractStateCovarianceInterpolator.interpolate(AbstractTimeInterpolator.InterpolationData interpolationData)
Interpolate orbit and associated covariance.
|
Modifier and Type | Method and Description |
---|---|
StateCovariance |
StateCovariance.changeCovarianceFrame(Orbit orbit,
Frame frameOut)
Get the covariance in the output frame.
|
StateCovariance |
StateCovariance.changeCovarianceFrame(Orbit orbit,
LOF lofOut)
Get the covariance in a given local orbital frame.
|
StateCovariance |
StateCovariance.changeCovarianceType(Orbit orbit,
OrbitType outOrbitType,
PositionAngleType outAngleType)
Get the covariance matrix in another orbit type.
|
protected StateCovariance |
StateCovarianceBlender.computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates,
Orbit interpolatedOrbit)
Compute the interpolated covariance expressed in the interpolated orbit frame.
|
protected StateCovariance |
StateCovarianceKeplerianHermiteInterpolator.computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates,
Orbit interpolatedOrbit)
Compute the interpolated covariance expressed in the interpolated orbit frame.
|
protected abstract StateCovariance |
AbstractStateCovarianceInterpolator.computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates,
Orbit interpolatedOrbit)
Compute the interpolated covariance expressed in the interpolated orbit frame.
|
protected TimeStampedPair<Orbit,StateCovariance> |
AbstractStateCovarianceInterpolator.expressCovarianceInDesiredOutput(Orbit interpolatedOrbit,
StateCovariance covarianceInOrbitFrame)
Express covariance in output configuration defined at this instance construction.
|
static org.hipparchus.linear.RealMatrix |
StateCovariance.getStm(Orbit initialOrbit,
double dt)
Get the state transition matrix considering Keplerian contribution only.
|
StateCovariance |
StateCovariance.shiftedBy(Orbit orbit,
double dt)
Get a time-shifted covariance matrix.
|
Modifier and Type | Method and Description |
---|---|
protected StateCovariance |
StateCovarianceBlender.computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates,
Orbit interpolatedOrbit)
Compute the interpolated covariance expressed in the interpolated orbit frame.
|
protected StateCovariance |
StateCovarianceKeplerianHermiteInterpolator.computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates,
Orbit interpolatedOrbit)
Compute the interpolated covariance expressed in the interpolated orbit frame.
|
protected abstract StateCovariance |
AbstractStateCovarianceInterpolator.computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates,
Orbit interpolatedOrbit)
Compute the interpolated covariance expressed in the interpolated orbit frame.
|
protected Orbit |
AbstractStateCovarianceInterpolator.interpolateOrbit(AbsoluteDate interpolationDate,
List<TimeStampedPair<Orbit,StateCovariance>> neighborList)
Interpolate orbit at given interpolation date.
|
Constructor and Description |
---|
SpacecraftState(Orbit orbit)
Build a spacecraft state from orbit only.
|
SpacecraftState(Orbit orbit,
Attitude attitude)
Build a spacecraft state from orbit and attitude.
|
SpacecraftState(Orbit orbit,
Attitude attitude,
double mass)
Build a spacecraft state from orbit, attitude and mass.
|
SpacecraftState(Orbit orbit,
Attitude attitude,
DoubleArrayDictionary additional)
Build a spacecraft state from orbit, attitude and additional states.
|
SpacecraftState(Orbit orbit,
Attitude attitude,
double mass,
DoubleArrayDictionary additional)
Build a spacecraft state from orbit, attitude, mass and additional states.
|
SpacecraftState(Orbit orbit,
Attitude attitude,
double mass,
DoubleArrayDictionary additional,
DoubleArrayDictionary additionalDot)
Build a spacecraft state from orbit, attitude, mass, additional states and derivatives.
|
SpacecraftState(Orbit orbit,
double mass)
Create a new instance from orbit and mass.
|
SpacecraftState(Orbit orbit,
DoubleArrayDictionary additional)
Build a spacecraft state from orbit and additional states.
|
SpacecraftState(Orbit orbit,
double mass,
DoubleArrayDictionary additional)
Create a new instance from orbit, mass and additional states.
|
Constructor and Description |
---|
AbstractStateCovarianceInterpolator(int interpolationPoints,
double extrapolationThreshold,
TimeInterpolator<Orbit> orbitInterpolator,
Frame outFrame,
OrbitType outOrbitType,
PositionAngleType outPositionAngleType)
Constructor.
|
AbstractStateCovarianceInterpolator(int interpolationPoints,
double extrapolationThreshold,
TimeInterpolator<Orbit> orbitInterpolator,
LOFType outLOF)
Constructor.
|
SpacecraftStateInterpolator(Frame outputFrame,
TimeInterpolator<Orbit> orbitInterpolator,
TimeInterpolator<AbsolutePVCoordinates> absPVAInterpolator,
TimeInterpolator<TimeStampedDouble> massInterpolator,
TimeInterpolator<Attitude> attitudeInterpolator,
TimeInterpolator<TimeStampedDouble> additionalStateInterpolator)
Constructor with:
Default number of interpolation points of
DEFAULT_INTERPOLATION_POINTS
Default extrapolation threshold of DEFAULT_EXTRAPOLATION_THRESHOLD_SEC s
|
SpacecraftStateInterpolator(int interpolationPoints,
double extrapolationThreshold,
Frame outputFrame,
TimeInterpolator<Orbit> orbitInterpolator,
TimeInterpolator<AbsolutePVCoordinates> absPVAInterpolator,
TimeInterpolator<TimeStampedDouble> massInterpolator,
TimeInterpolator<Attitude> attitudeInterpolator,
TimeInterpolator<TimeStampedDouble> additionalStateInterpolator)
Constructor.
|
StateCovarianceBlender(org.hipparchus.analysis.polynomials.SmoothStepFactory.SmoothStepFunction blendingFunction,
TimeInterpolator<Orbit> orbitInterpolator,
Frame outFrame,
OrbitType outOrbitType,
PositionAngleType outPositionAngleType)
Constructor.
|
StateCovarianceBlender(org.hipparchus.analysis.polynomials.SmoothStepFactory.SmoothStepFunction blendingFunction,
TimeInterpolator<Orbit> orbitInterpolator,
LOFType outLOF)
Constructor.
|
StateCovarianceKeplerianHermiteInterpolator(int interpolationPoints,
double extrapolationThreshold,
TimeInterpolator<Orbit> orbitInterpolator,
CartesianDerivativesFilter filter,
Frame outFrame,
OrbitType outOrbitType,
PositionAngleType outPositionAngleType)
Constructor using an output frame.
|
StateCovarianceKeplerianHermiteInterpolator(int interpolationPoints,
double extrapolationThreshold,
TimeInterpolator<Orbit> orbitInterpolator,
CartesianDerivativesFilter filter,
LOFType outLOF)
Constructor using an output local orbital frame.
|
StateCovarianceKeplerianHermiteInterpolator(int interpolationPoints,
TimeInterpolator<Orbit> orbitInterpolator,
CartesianDerivativesFilter filter,
Frame outFrame,
OrbitType outOrbitType,
PositionAngleType outPositionAngleType)
Constructor using an output frame and :
Default extrapolation threshold value (
DEFAULT_EXTRAPOLATION_THRESHOLD_SEC s)
As this implementation of interpolation is polynomial, it should be used only with small number of interpolation
points (about 10-20 points) in order to avoid Runge's
phenomenon and numerical problems (including NaN appearing). |
StateCovarianceKeplerianHermiteInterpolator(int interpolationPoints,
TimeInterpolator<Orbit> orbitInterpolator,
CartesianDerivativesFilter filter,
LOFType outLOF)
Constructor using an output local orbital frame and :
Use of position and two time derivatives during interpolation
As this implementation of interpolation is polynomial, it should be used only with small number of interpolation
points (about 10-20 points) in order to avoid Runge's
phenomenon and numerical problems (including NaN appearing).
|
StateCovarianceKeplerianHermiteInterpolator(int interpolationPoints,
TimeInterpolator<Orbit> orbitInterpolator,
Frame outFrame,
OrbitType outOrbitType,
PositionAngleType outPositionAngleType)
Constructor using an output frame and :
Default number of interpolation points of
DEFAULT_INTERPOLATION_POINTS
Use of position and two time derivatives during interpolation
As this implementation of interpolation is polynomial, it should be used only with small number of interpolation
points (about 10-20 points) in order to avoid Runge's
phenomenon and numerical problems (including NaN appearing). |
StateCovarianceKeplerianHermiteInterpolator(int interpolationPoints,
TimeInterpolator<Orbit> orbitInterpolator,
LOFType outLOF)
Constructor using an output local orbital frame and :
Default extrapolation threshold value (
DEFAULT_EXTRAPOLATION_THRESHOLD_SEC s)
Use of position and two time derivatives during interpolation
As this implementation of interpolation is polynomial, it should be used only with small number of interpolation
points (about 10-20 points) in order to avoid Runge's
phenomenon and numerical problems (including NaN appearing). |
StateCovarianceKeplerianHermiteInterpolator(TimeInterpolator<Orbit> orbitInterpolator,
Frame outFrame,
OrbitType outOrbitType,
PositionAngleType outPositionAngleType)
Constructor using an output frame and :
Default number of interpolation points of
DEFAULT_INTERPOLATION_POINTS
Default extrapolation threshold value (DEFAULT_EXTRAPOLATION_THRESHOLD_SEC s)
Use of position and two time derivatives during interpolation
As this implementation of interpolation is polynomial, it should be used only with small number of interpolation
points (about 10-20 points) in order to avoid Runge's
phenomenon and numerical problems (including NaN appearing). |
StateCovarianceKeplerianHermiteInterpolator(TimeInterpolator<Orbit> orbitInterpolator,
LOFType outLOF)
Constructor using an output local orbital frame and :
Default number of interpolation points of
DEFAULT_INTERPOLATION_POINTS
Default extrapolation threshold value (DEFAULT_EXTRAPOLATION_THRESHOLD_SEC s)
Use of position and two time derivatives during interpolation
As this implementation of interpolation is polynomial, it should be used only with small number of interpolation
points (about 10-20 points) in order to avoid Runge's
phenomenon and numerical problems (including NaN appearing). |
Modifier and Type | Method and Description |
---|---|
Orbit |
J2DifferentialEffect.apply(Orbit orbit1)
Compute the effect of the maneuver on an orbit.
|
protected Orbit |
AdapterPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
protected Orbit |
AggregateBoundedPropagator.propagateOrbit(AbsoluteDate date) |
protected abstract Orbit |
AbstractAnalyticalPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
protected Orbit |
Ephemeris.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
protected Orbit |
KeplerianPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
Modifier and Type | Method and Description |
---|---|
Optional<TimeInterpolator<TimeStampedPair<Orbit,StateCovariance>>> |
Ephemeris.getCovarianceInterpolator()
Get covariance interpolator.
|
Modifier and Type | Method and Description |
---|---|
Orbit |
J2DifferentialEffect.apply(Orbit orbit1)
Compute the effect of the maneuver on an orbit.
|
static CircularOrbit |
EcksteinHechlerPropagator.computeMeanOrbit(Orbit osculating,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double c60,
double epsilon,
int maxIterations)
Conversion from osculating to mean orbit.
|
static KeplerianOrbit |
BrouwerLyddanePropagator.computeMeanOrbit(Orbit osculating,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double M2Value,
double epsilon,
int maxIterations)
Conversion from osculating to mean orbit.
|
static CircularOrbit |
EcksteinHechlerPropagator.computeMeanOrbit(Orbit osculating,
UnnormalizedSphericalHarmonicsProvider provider,
UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics)
Conversion from osculating to mean orbit.
|
static KeplerianOrbit |
BrouwerLyddanePropagator.computeMeanOrbit(Orbit osculating,
UnnormalizedSphericalHarmonicsProvider provider,
UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics,
double M2Value)
Conversion from osculating to mean orbit.
|
static KeplerianOrbit |
BrouwerLyddanePropagator.computeMeanOrbit(Orbit osculating,
UnnormalizedSphericalHarmonicsProvider provider,
UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics,
double M2Value,
double epsilon,
int maxIterations)
Conversion from osculating to mean orbit.
|
static CircularOrbit |
EcksteinHechlerPropagator.computeMeanOrbit(Orbit osculating,
UnnormalizedSphericalHarmonicsProvider provider,
UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics,
double epsilon,
int maxIterations)
Conversion from osculating to mean orbit.
|
Modifier and Type | Method and Description |
---|---|
static void |
Ephemeris.checkInputConsistency(List<SpacecraftState> states,
TimeInterpolator<SpacecraftState> stateInterpolator,
List<StateCovariance> covariances,
TimeInterpolator<TimeStampedPair<Orbit,StateCovariance>> covarianceInterpolator)
Check input consistency between states, covariances and their associated interpolators.
|
Constructor and Description |
---|
BrouwerLyddanePropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double M2)
Build a propagator from orbit, attitude provider and potential.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double M2)
Build a propagator from orbit, attitude provider, mass and potential.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
PropagationType initialType,
double M2)
Build a propagator from orbit, attitude provider, mass and potential.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
PropagationType initialType,
double M2,
double epsilon,
int maxIterations)
Build a propagator from orbit, attitude provider, mass and potential.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
UnnormalizedSphericalHarmonicsProvider provider,
double M2)
Build a propagator from orbit, attitude provider, mass and potential provider.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
UnnormalizedSphericalHarmonicsProvider provider,
PropagationType initialType,
double M2)
Build a propagator from orbit, attitude provider, mass and potential provider.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
AttitudeProvider attitude,
double mass,
UnnormalizedSphericalHarmonicsProvider provider,
UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics,
double M2)
Private helper constructor.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
AttitudeProvider attitude,
double mass,
UnnormalizedSphericalHarmonicsProvider provider,
UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics,
PropagationType initialType,
double M2)
Private helper constructor.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
UnnormalizedSphericalHarmonicsProvider provider,
double M2)
Build a propagator from orbit, attitude provider and potential provider.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double M2)
Build a propagator from orbit and potential.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
double mass,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double M2)
Build a propagator from orbit, mass and potential.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
double mass,
UnnormalizedSphericalHarmonicsProvider provider,
double M2)
Build a propagator from orbit, mass and potential provider.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
double M2)
Build a propagator from orbit and potential provider.
|
BrouwerLyddanePropagator(Orbit initialOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PropagationType initialType,
double M2)
Build a propagator from orbit and potential provider.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double c60)
Build a propagator from orbit, attitude provider and potential.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double c60)
Build a propagator from orbit, attitude provider, mass and potential.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double c60,
PropagationType initialType)
Build a propagator from orbit, attitude provider, mass and potential.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double c60,
PropagationType initialType,
double epsilon,
int maxIterations)
Build a propagator from orbit, attitude provider, mass and potential.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
UnnormalizedSphericalHarmonicsProvider provider)
Build a propagator from orbit, attitude provider, mass and potential provider.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mass,
UnnormalizedSphericalHarmonicsProvider provider,
PropagationType initialType)
Build a propagator from orbit, attitude provider, mass and potential provider.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
AttitudeProvider attitude,
double mass,
UnnormalizedSphericalHarmonicsProvider provider,
UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics)
Private helper constructor.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
AttitudeProvider attitude,
double mass,
UnnormalizedSphericalHarmonicsProvider provider,
UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics,
PropagationType initialType)
Private helper constructor.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
UnnormalizedSphericalHarmonicsProvider provider)
Build a propagator from orbit, attitude provider and potential provider.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double c60)
Build a propagator from orbit and potential.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
double mass,
double referenceRadius,
double mu,
double c20,
double c30,
double c40,
double c50,
double c60)
Build a propagator from orbit, mass and potential.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
double mass,
UnnormalizedSphericalHarmonicsProvider provider)
Build a propagator from orbit, mass and potential provider.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
UnnormalizedSphericalHarmonicsProvider provider)
Build a propagator from orbit and potential provider.
|
EcksteinHechlerPropagator(Orbit initialOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PropagationType initialType)
Build a propagator from orbit and potential provider.
|
J2DifferentialEffect(Orbit orbit0,
Orbit orbit1,
boolean applyBefore,
double referenceRadius,
double mu,
double j2)
Simple constructor.
|
J2DifferentialEffect(Orbit orbit0,
Orbit orbit1,
boolean applyBefore,
UnnormalizedSphericalHarmonicsProvider gravityField)
Simple constructor.
|
KeplerianPropagator(Orbit initialOrbit)
Build a propagator from orbit only.
|
KeplerianPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv)
Build a propagator from orbit and attitude provider.
|
KeplerianPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mu)
Build a propagator from orbit, attitude provider and central attraction
coefficient ฮผ.
|
KeplerianPropagator(Orbit initialOrbit,
AttitudeProvider attitudeProv,
double mu,
double mass)
Build propagator from orbit, attitude provider, central attraction
coefficient ฮผ and mass.
|
KeplerianPropagator(Orbit initialOrbit,
double mu)
Build a propagator from orbit and central attraction coefficient ฮผ.
|
Constructor and Description |
---|
Ephemeris(List<SpacecraftState> states,
TimeInterpolator<SpacecraftState> stateInterpolator,
List<StateCovariance> covariances,
TimeInterpolator<TimeStampedPair<Orbit,StateCovariance>> covarianceInterpolator)
Constructor with tabulated states and associated covariances.
|
Ephemeris(List<SpacecraftState> states,
TimeInterpolator<SpacecraftState> stateInterpolator,
List<StateCovariance> covariances,
TimeInterpolator<TimeStampedPair<Orbit,StateCovariance>> covarianceInterpolator,
AttitudeProvider attitudeProvider)
Constructor with tabulated states and associated covariances.
|
Modifier and Type | Method and Description |
---|---|
protected Orbit |
GNSSPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
protected Orbit |
GLONASSAnalyticalPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
protected Orbit |
SBASPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
Modifier and Type | Method and Description |
---|---|
protected Orbit |
TLEPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
Modifier and Type | Method and Description |
---|---|
protected Orbit |
AbstractPropagatorBuilder.createInitialOrbit()
Build an initial orbit using the current selected parameters.
|
Modifier and Type | Method and Description |
---|---|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
MidpointFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
GillFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
LutherFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
abstract org.hipparchus.ode.AbstractFieldIntegrator<T> |
AbstractVariableStepFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
DormandPrince54FieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
abstract org.hipparchus.ode.AbstractFieldIntegrator<T> |
AbstractFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
AdamsBashforthFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
EulerFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
FieldODEIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
ThreeEighthesFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
ClassicalRungeKuttaFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
HighamHall54FieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
DormandPrince853FieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractFieldIntegrator<T> |
AdamsMoultonFieldIntegratorBuilder.buildIntegrator(org.hipparchus.Field<T> field,
Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
MidpointIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
ClassicalRungeKuttaIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
DormandPrince853IntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
HighamHall54IntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
AdamsMoultonIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
EulerIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
AdamsBashforthIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
LutherIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
ThreeEighthesIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
ODEIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
DormandPrince54IntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
GraggBulirschStoerIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
org.hipparchus.ode.AbstractIntegrator |
GillIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
void |
AbstractPropagatorBuilder.resetOrbit(Orbit newOrbit)
Reset the orbit in the propagator builder.
|
void |
PropagatorBuilder.resetOrbit(Orbit newOrbit)
Reset the orbit in the propagator builder.
|
void |
DSSTPropagatorBuilder.resetOrbit(Orbit newOrbit,
PropagationType orbitType)
Reset the orbit in the propagator builder.
|
Constructor and Description |
---|
AbstractPropagatorBuilder(Orbit templateOrbit,
PositionAngleType positionAngleType,
double positionScale,
boolean addDriverForCentralAttraction)
Build a new instance.
|
AbstractPropagatorBuilder(Orbit templateOrbit,
PositionAngleType positionAngleType,
double positionScale,
boolean addDriverForCentralAttraction,
AttitudeProvider attitudeProvider)
Build a new instance.
|
BrouwerLyddanePropagatorBuilder(Orbit templateOrbit,
double referenceRadius,
double mu,
TideSystem tideSystem,
double c20,
double c30,
double c40,
double c50,
OrbitType orbitType,
PositionAngleType positionAngleType,
double positionScale,
double M2)
Build a new instance.
|
BrouwerLyddanePropagatorBuilder(Orbit templateOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PositionAngleType positionAngleType,
double positionScale,
AttitudeProvider attitudeProvider,
double M2)
Build a new instance.
|
BrouwerLyddanePropagatorBuilder(Orbit templateOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PositionAngleType positionAngleType,
double positionScale,
double M2)
Build a new instance.
|
DSSTPropagatorBuilder(Orbit referenceOrbit,
ODEIntegratorBuilder builder,
double positionScale,
PropagationType propagationType,
PropagationType stateType)
Build a new instance.
|
DSSTPropagatorBuilder(Orbit referenceOrbit,
ODEIntegratorBuilder builder,
double positionScale,
PropagationType propagationType,
PropagationType stateType,
AttitudeProvider attitudeProvider)
Build a new instance.
|
EcksteinHechlerPropagatorBuilder(Orbit templateOrbit,
double referenceRadius,
double mu,
TideSystem tideSystem,
double c20,
double c30,
double c40,
double c50,
double c60,
OrbitType orbitType,
PositionAngleType positionAngleType,
double positionScale)
Build a new instance.
|
EcksteinHechlerPropagatorBuilder(Orbit templateOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PositionAngleType positionAngleType,
double positionScale)
Build a new instance.
|
EcksteinHechlerPropagatorBuilder(Orbit templateOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PositionAngleType positionAngleType,
double positionScale,
AttitudeProvider attitudeProvider)
Build a new instance.
|
KeplerianPropagatorBuilder(Orbit templateOrbit,
PositionAngleType positionAngleType,
double positionScale)
Build a new instance.
|
KeplerianPropagatorBuilder(Orbit templateOrbit,
PositionAngleType positionAngleType,
double positionScale,
AttitudeProvider attitudeProvider)
Build a new instance.
|
NumericalPropagatorBuilder(Orbit referenceOrbit,
ODEIntegratorBuilder builder,
PositionAngleType positionAngleType,
double positionScale)
Build a new instance.
|
NumericalPropagatorBuilder(Orbit referenceOrbit,
ODEIntegratorBuilder builder,
PositionAngleType positionAngleType,
double positionScale,
AttitudeProvider attitudeProvider)
Build a new instance.
|
Constructor and Description |
---|
EphemerisPropagatorBuilder(List<SpacecraftState> states,
TimeInterpolator<SpacecraftState> stateInterpolator,
List<StateCovariance> covariances,
TimeInterpolator<TimeStampedPair<Orbit,StateCovariance>> covarianceInterpolator)
Constructor with covariances and default attitude provider.
|
EphemerisPropagatorBuilder(List<SpacecraftState> states,
TimeInterpolator<SpacecraftState> stateInterpolator,
List<StateCovariance> covariances,
TimeInterpolator<TimeStampedPair<Orbit,StateCovariance>> covarianceInterpolator,
AttitudeProvider attitudeProvider)
Constructor.
|
Constructor and Description |
---|
AlignmentDetector(double threshold,
Orbit orbit,
PVCoordinatesProvider body,
double alignAngle)
Build a new alignment detector.
|
AlignmentDetector(Orbit orbit,
PVCoordinatesProvider body,
double alignAngle)
Build a new alignment detector.
|
ApsideDetector(double threshold,
Orbit orbit)
Build a new instance.
|
ApsideDetector(Orbit orbit)
Build a new instance.
|
NodeDetector(double threshold,
Orbit orbit,
Frame frame)
Build a new instance.
|
NodeDetector(Orbit orbit,
Frame frame)
Build a new instance.
|
Modifier and Type | Method and Description |
---|---|
protected Orbit |
IntegratedEphemeris.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
Modifier and Type | Method and Description |
---|---|
static double[][] |
NumericalPropagator.tolerances(double dP,
double dV,
Orbit orbit,
OrbitType type)
Estimate tolerance vectors for integrators when propagating in orbits.
|
static double[][] |
NumericalPropagator.tolerances(double dP,
Orbit orbit,
OrbitType type)
Estimate tolerance vectors for integrators when propagating in orbits.
|
Modifier and Type | Method and Description |
---|---|
static double[][] |
DSSTPropagator.tolerances(double dP,
double dV,
Orbit orbit)
Estimate tolerance vectors for an AdaptativeStepsizeIntegrator.
|
static double[][] |
DSSTPropagator.tolerances(double dP,
Orbit orbit)
Estimate tolerance vectors for an AdaptativeStepsizeIntegrator.
|
Modifier and Type | Method and Description |
---|---|
double[] |
ShortPeriodTerms.value(Orbit meanOrbit)
Evaluate the contributions of the short period terms.
|
double[] |
AbstractGaussianContribution.GaussianShortPeriodicCoefficients.value(Orbit meanOrbit)
Evaluate the contributions of the short period terms.
|
Modifier and Type | Method and Description |
---|---|
Orbit |
AuxiliaryElements.getOrbit()
Get the orbit.
|
Constructor and Description |
---|
AuxiliaryElements(Orbit orbit,
int retrogradeFactor)
Simple constructor.
|
Modifier and Type | Method and Description |
---|---|
protected Orbit |
AbstractShortTermEncounter2DPOCMethod.getObjectOrbitFromCdm(CdmRelativeMetadata cdmRelativeMetadata,
CdmData cdmData,
CdmMetadata cdmMetadata,
DataContext cdmDataContext)
Extract collision object spacecraft state from given
Conjunction Data Message data. |
Orbit |
ShortTermEncounter2DDefinition.getOtherAtTCA()
Get other's orbit at time of closest approach.
|
Orbit |
ShortTermEncounter2DDefinition.getReferenceAtTCA()
Get reference's orbit at time of closest approach.
|
Modifier and Type | Method and Description |
---|---|
default ProbabilityOfCollision |
ShortTermEncounter2DPOCMethod.compute(Orbit primaryAtTCA,
StateCovariance primaryCovariance,
double primaryRadius,
Orbit secondaryAtTCA,
StateCovariance secondaryCovariance,
double secondaryRadius)
Compute the probability of collision using parameters necessary for creating a
collision definition instance. |
ProbabilityOfCollision |
AbstractShortTermEncounter1DNumerical2DPOCMethod.compute(Orbit primaryAtTCA,
StateCovariance primaryCovariance,
double primaryRadius,
Orbit secondaryAtTCA,
StateCovariance secondaryCovariance,
double secondaryRadius,
org.hipparchus.analysis.integration.UnivariateIntegrator customIntegrator,
int customMaxNbOfEval,
double zeroThreshold)
Compute the probability of collision using parameters necessary for creating a
collision definition instance. |
default ProbabilityOfCollision |
ShortTermEncounter2DPOCMethod.compute(Orbit primaryAtTCA,
StateCovariance primaryCovariance,
Orbit secondaryAtTCA,
StateCovariance secondaryCovariance,
double combinedRadius)
Compute the probability of collision using parameters necessary for creating a
collision definition instance. |
ProbabilityOfCollision |
AbstractShortTermEncounter2DPOCMethod.compute(Orbit primaryAtTCA,
StateCovariance primaryCovariance,
Orbit secondaryAtTCA,
StateCovariance secondaryCovariance,
double combinedRadius,
double zeroThreshold)
Compute the probability of collision using parameters necessary for creating a
collision definition instance. |
ProbabilityOfCollision |
ShortTermEncounter2DPOCMethod.compute(Orbit primaryAtTCA,
StateCovariance primaryCovariance,
Orbit secondaryAtTCA,
StateCovariance secondaryCovariance,
double combinedRadius,
double zeroThreshold)
Compute the probability of collision using parameters necessary for creating a
collision definition instance. |
Constructor and Description |
---|
ShortTermEncounter2DDefinition(Orbit referenceAtTCA,
StateCovariance referenceCovariance,
double referenceRadius,
Orbit otherAtTCA,
StateCovariance otherCovariance,
double otherRadius)
Constructor.
|
ShortTermEncounter2DDefinition(Orbit referenceAtTCA,
StateCovariance referenceCovariance,
double referenceRadius,
Orbit otherAtTCA,
StateCovariance otherCovariance,
double otherRadius,
EncounterLOFType encounterFrameType,
double tcaTolerance)
Constructor.
|
ShortTermEncounter2DDefinition(Orbit referenceAtTCA,
StateCovariance referenceCovariance,
Orbit otherAtTCA,
StateCovariance otherCovariance,
double combinedRadius)
Constructor.
|
ShortTermEncounter2DDefinition(Orbit referenceAtTCA,
StateCovariance referenceCovariance,
Orbit otherAtTCA,
StateCovariance otherCovariance,
double combinedRadius,
EncounterLOFType encounterFrameType,
double tcaTolerance)
Constructor.
|
Modifier and Type | Method and Description |
---|---|
static <T extends org.hipparchus.CalculusFieldElement<T>> |
Fieldifier.fieldify(org.hipparchus.Field<T> field,
Orbit orbit)
Fieldify given orbit with given field.
|
Copyright © 2002-2023 CS GROUP. All rights reserved.