Package | Description |
---|---|
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).
|
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.
|
protected Orbit |
TLEBatchLSModel.configureOrbits(MatricesHarvester harvester,
Propagator propagator)
Deprecated.
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,
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,
PositionAngle positionAngle,
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.
|
abstract Orbit |
OrbitType.mapArrayToOrbit(double[] array,
double[] arrayDot,
PositionAngle 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 Orbit |
OrbitType.convertType(Orbit orbit)
Convert an orbit to the instance type.
|
abstract ParameterDriversList |
OrbitType.getDrivers(double dP,
Orbit orbit,
PositionAngle type)
Get parameters drivers initialized from a reference orbit.
|
abstract void |
OrbitType.mapOrbitToArray(Orbit orbit,
PositionAngle 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 |
---|---|
EquinoctialOrbit |
EquinoctialOrbit.interpolate(AbsoluteDate date,
Stream<Orbit> sample)
Get an interpolated instance.
|
KeplerianOrbit |
KeplerianOrbit.interpolate(AbsoluteDate date,
Stream<Orbit> sample)
Get an interpolated instance.
|
CircularOrbit |
CircularOrbit.interpolate(AbsoluteDate date,
Stream<Orbit> sample)
Get an interpolated instance.
|
CartesianOrbit |
CartesianOrbit.interpolate(AbsoluteDate date,
Stream<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.
|
KeplerianOrbit(Orbit op)
Constructor from any kind of orbital parameters.
|
Modifier and Type | Method and Description |
---|---|
Orbit |
SpacecraftState.getOrbit()
Get the current orbit.
|
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,
Attitude attitude,
double mass,
Map<String,double[]> additional)
Deprecated.
as of 11.1, replaced by
SpacecraftState.SpacecraftState(Orbit, Attitude, double, DoubleArrayDictionary) |
SpacecraftState(Orbit orbit,
Attitude attitude,
Map<String,double[]> additional)
Deprecated.
as of 11.1, replaced by
SpacecraftState.SpacecraftState(Orbit, Attitude, DoubleArrayDictionary) |
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.
|
SpacecraftState(Orbit orbit,
double mass,
Map<String,double[]> additional)
Deprecated.
as of 11.1, replaced by
SpacecraftState.SpacecraftState(Orbit, double, DoubleArrayDictionary) |
SpacecraftState(Orbit orbit,
Map<String,double[]> additional)
Deprecated.
as of 11.1, replaced by
SpacecraftState.SpacecraftState(Orbit, DoubleArrayDictionary) |
Modifier and Type | Method and Description |
---|---|
Orbit |
J2DifferentialEffect.apply(Orbit orbit1)
Compute the effect of the maneuver on an orbit.
|
protected Orbit |
KeplerianPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
protected Orbit |
AggregateBoundedPropagator.propagateOrbit(AbsoluteDate date) |
protected Orbit |
Ephemeris.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
protected abstract Orbit |
AbstractAnalyticalPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
protected Orbit |
AdapterPropagator.propagateOrbit(AbsoluteDate date)
Extrapolate an orbit up to a specific target date.
|
Modifier and Type | Method and Description |
---|---|
Orbit |
J2DifferentialEffect.apply(Orbit orbit1)
Compute the effect of the maneuver on an orbit.
|
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,
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,
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 μ.
|
Modifier and Type | Method and Description |
---|---|
protected Orbit |
SBASPropagator.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 |
GNSSPropagator.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 |
---|---|
AbstractIntegrator |
HighamHall54IntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
DormandPrince853IntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
DormandPrince54IntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
EulerIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
MidpointIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
ODEIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
ClassicalRungeKuttaIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
AdamsBashforthIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
AdamsMoultonIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
LutherIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
GraggBulirschStoerIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
GillIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
AbstractIntegrator |
ThreeEighthesIntegratorBuilder.buildIntegrator(Orbit orbit,
OrbitType orbitType)
Build a first order integrator.
|
void |
AbstractPropagatorBuilder.resetOrbit(Orbit newOrbit)
Reset the orbit in the propagator builder.
|
void |
OrbitDeterminationPropagatorBuilder.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,
PositionAngle positionAngle,
double positionScale,
boolean addDriverForCentralAttraction)
Build a new instance.
|
AbstractPropagatorBuilder(Orbit templateOrbit,
PositionAngle positionAngle,
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,
PositionAngle positionAngle,
double positionScale,
double M2)
Build a new instance.
|
BrouwerLyddanePropagatorBuilder(Orbit templateOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PositionAngle positionAngle,
double positionScale,
AttitudeProvider attitudeProvider,
double M2)
Build a new instance.
|
BrouwerLyddanePropagatorBuilder(Orbit templateOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PositionAngle positionAngle,
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,
PositionAngle positionAngle,
double positionScale)
Build a new instance.
|
EcksteinHechlerPropagatorBuilder(Orbit templateOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PositionAngle positionAngle,
double positionScale)
Build a new instance.
|
EcksteinHechlerPropagatorBuilder(Orbit templateOrbit,
UnnormalizedSphericalHarmonicsProvider provider,
PositionAngle positionAngle,
double positionScale,
AttitudeProvider attitudeProvider)
Build a new instance.
|
KeplerianPropagatorBuilder(Orbit templateOrbit,
PositionAngle positionAngle,
double positionScale)
Build a new instance.
|
KeplerianPropagatorBuilder(Orbit templateOrbit,
PositionAngle positionAngle,
double positionScale,
AttitudeProvider attitudeProvider)
Build a new instance.
|
NumericalPropagatorBuilder(Orbit referenceOrbit,
ODEIntegratorBuilder builder,
PositionAngle positionAngle,
double positionScale)
Build a new instance.
|
NumericalPropagatorBuilder(Orbit referenceOrbit,
ODEIntegratorBuilder builder,
PositionAngle positionAngle,
double positionScale,
AttitudeProvider attitudeProvider)
Build a new instance.
|
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.
|
Constructor and Description |
---|
AuxiliaryElements(Orbit orbit,
int retrogradeFactor)
Simple constructor.
|
Copyright © 2002-2022 CS GROUP. All rights reserved.