Package | Description |
---|---|
org.orekit.attitudes |
This package provides classes to represent simple attitudes.
|
org.orekit.estimation.measurements |
The measurements package defines everything that is related to orbit
determination measurements.
|
org.orekit.estimation.measurements.generation |
This package provides Orbit Determination measurements generation.
|
org.orekit.estimation.measurements.modifiers | |
org.orekit.estimation.sequential | |
org.orekit.files.ccsds |
This package provides a parser for orbit data stored in CCSDS Orbit Data Message format.
|
org.orekit.files.general |
This package provides interfaces for orbit file representations and corresponding
parsers.
|
org.orekit.forces |
This package provides the interface for force models that will be used by the
NumericalPropagator , as well as
some classical spacecraft models for surface forces (spherical, box and solar array ...). |
org.orekit.forces.drag |
This package provides all drag-related forces.
|
org.orekit.forces.gravity |
This package provides all gravity-related forces.
|
org.orekit.forces.maneuvers |
This package provides models of simple maneuvers.
|
org.orekit.forces.radiation |
This package provides all radiation pressure related forces.
|
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.events.handlers |
This package provides an interface and classes dealing with events occurrence only.
|
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.sampling |
This package provides interfaces and classes dealing with step handling during propagation.
|
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.utils |
This package provides useful objects.
|
Modifier and Type | Method | Description |
---|---|---|
void |
AttitudesSequence.SwitchHandler.switchOccurred(AttitudeProvider preceding,
AttitudeProvider following,
SpacecraftState state) |
Method called when attitude is switched from one law to another law.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState[] |
EstimatedMeasurement.getStates() |
Get the states of the spacecrafts.
|
Modifier and Type | Method | Description |
---|---|---|
EstimatedMeasurement<T> |
AbstractMeasurement.estimate(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value of the measurement.
|
EstimatedMeasurement<T> |
ObservedMeasurement.estimate(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value of the measurement.
|
static TimeStampedFieldPVCoordinates<org.hipparchus.analysis.differentiation.DerivativeStructure> |
AbstractMeasurement.getCoordinates(SpacecraftState state,
int firstDerivative,
org.hipparchus.analysis.differentiation.DSFactory factory) |
Get Cartesian coordinates as derivatives.
|
protected abstract EstimatedMeasurement<T> |
AbstractMeasurement.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
protected EstimatedMeasurement<AngularAzEl> |
AngularAzEl.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
protected EstimatedMeasurement<AngularRaDec> |
AngularRaDec.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
protected EstimatedMeasurement<InterSatellitesRange> |
InterSatellitesRange.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
protected EstimatedMeasurement<Phase> |
Phase.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
protected EstimatedMeasurement<Position> |
Position.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
protected EstimatedMeasurement<PV> |
PV.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
protected EstimatedMeasurement<Range> |
Range.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
protected EstimatedMeasurement<RangeRate> |
RangeRate.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
protected EstimatedMeasurement<TurnAroundRange> |
TurnAroundRange.theoreticalEvaluation(int iteration,
int evaluation,
SpacecraftState[] states) |
Estimate the theoretical value.
|
Constructor | Description |
---|---|
EstimatedMeasurement(T observedMeasurement,
int iteration,
int count,
SpacecraftState[] states,
TimeStampedPVCoordinates[] participants) |
Simple constructor.
|
Modifier and Type | Method | Description |
---|---|---|
AngularAzEl |
AngularAzElBuilder.build(SpacecraftState[] states) |
Generate a single measurement.
|
AngularRaDec |
AngularRaDecBuilder.build(SpacecraftState[] states) |
Generate a single measurement.
|
InterSatellitesRange |
InterSatellitesRangeBuilder.build(SpacecraftState[] states) |
Generate a single measurement.
|
T |
MeasurementBuilder.build(SpacecraftState[] states) |
Generate a single measurement.
|
Position |
PositionBuilder.build(SpacecraftState[] states) |
Generate a single measurement.
|
PV |
PVBuilder.build(SpacecraftState[] states) |
Generate a single measurement.
|
Range |
RangeBuilder.build(SpacecraftState[] states) |
Generate a single measurement.
|
RangeRate |
RangeRateBuilder.build(SpacecraftState[] states) |
Generate a single measurement.
|
TurnAroundRange |
TurnAroundRangeBuilder.build(SpacecraftState[] states) |
Generate a single measurement.
|
Modifier and Type | Method | Description |
---|---|---|
double |
RangeRateTroposphericDelayModifier.rangeRateErrorTroposphericModel(GroundStation station,
SpacecraftState state) |
Compute the measurement error due to Troposphere.
|
Constructor | Description |
---|---|
TroposphericDSConverter(SpacecraftState state,
int freeStateParameters,
AttitudeProvider provider) |
Simple constructor.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState[] |
KalmanEstimation.getCorrectedSpacecraftStates() |
Get the corrected spacecraft states.
|
SpacecraftState[] |
Model.getCorrectedSpacecraftStates() |
Get the corrected spacecraft states.
|
SpacecraftState[] |
KalmanEstimation.getPredictedSpacecraftStates() |
Get the predicted spacecraft states.
|
SpacecraftState[] |
Model.getPredictedSpacecraftStates() |
Get the predicted spacecraft states.
|
Modifier and Type | Method | Description |
---|---|---|
org.hipparchus.linear.RealMatrix |
AbstractCovarianceMatrixProvider.getInitialCovarianceMatrix(SpacecraftState initial) |
Get the initial covariance matrix.
|
org.hipparchus.linear.RealMatrix |
CovarianceMatrixProvider.getInitialCovarianceMatrix(SpacecraftState initial) |
Get the initial covariance matrix.
|
org.hipparchus.linear.RealMatrix |
ConstantProcessNoise.getProcessNoiseMatrix(SpacecraftState previous,
SpacecraftState current) |
Get the process noise matrix between previous and current states.
|
org.hipparchus.linear.RealMatrix |
CovarianceMatrixProvider.getProcessNoiseMatrix(SpacecraftState previous,
SpacecraftState current) |
Get the process noise matrix between previous and current states.
|
org.hipparchus.linear.RealMatrix |
UnivariateProcessNoise.getProcessNoiseMatrix(SpacecraftState previous,
SpacecraftState current) |
Get the process noise matrix between previous and current states.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
OMMFile.generateSpacecraftState() |
Generate spacecraft state from the
KeplerianOrbit generated by generateKeplerianOrbit. |
SpacecraftState |
OPMFile.generateSpacecraftState() |
Generate spacecraft state from the
CartesianOrbit generated by generateCartesianOrbit. |
Modifier and Type | Method | Description |
---|---|---|
void |
StreamingOemWriter.Segment.handleStep(SpacecraftState s,
boolean isLast) |
|
void |
StreamingOemWriter.Segment.init(SpacecraftState s0,
AbsoluteDate t,
double step) |
Initialize step handler at the start of a propagation.
|
Modifier and Type | Method | Description |
---|---|---|
OrekitEphemerisFile.OrekitEphemerisSegment |
OrekitEphemerisFile.OrekitSatelliteEphemeris.addNewSegment(List<SpacecraftState> states) |
Injects pre-computed satellite states into this ephemeris file
object, returning the generated
OrekitEphemerisFile.OrekitEphemerisSegment that
has been stored internally. |
OrekitEphemerisFile.OrekitEphemerisSegment |
OrekitEphemerisFile.OrekitSatelliteEphemeris.addNewSegment(List<SpacecraftState> states,
int interpolationSampleSize) |
Injects pre-computed satellite states into this ephemeris file
object, returning the generated
OrekitEphemerisFile.OrekitEphemerisSegment that
has been stored internally. |
OrekitEphemerisFile.OrekitEphemerisSegment |
OrekitEphemerisFile.OrekitSatelliteEphemeris.addNewSegment(List<SpacecraftState> states,
CelestialBody body,
int interpolationSampleSize) |
Injects pre-computed satellite states into this ephemeris file
object, returning the generated
OrekitEphemerisFile.OrekitEphemerisSegment that
has been stored internally. |
Modifier and Type | Method | Description |
---|---|---|
org.hipparchus.geometry.euclidean.threed.Vector3D |
AbstractParametricAcceleration.acceleration(SpacecraftState state,
double[] parameters) |
Compute acceleration.
|
org.hipparchus.geometry.euclidean.threed.Vector3D |
ForceModel.acceleration(SpacecraftState s,
double[] parameters) |
Compute acceleration.
|
default void |
ForceModel.addContribution(SpacecraftState s,
TimeDerivativesEquations adder) |
Compute the contribution of the force model to the perturbing
acceleration.
|
default void |
ForceModel.init(SpacecraftState initialState,
AbsoluteDate target) |
Initialize the force model at the start of propagation.
|
void |
HarmonicParametricAcceleration.init(SpacecraftState initialState,
AbsoluteDate target) |
Initialize the force model at the start of propagation.
|
void |
PolynomialParametricAcceleration.init(SpacecraftState initialState,
AbsoluteDate target) |
Initialize the force model at the start of propagation.
|
protected abstract double |
AbstractParametricAcceleration.signedAmplitude(SpacecraftState state,
double[] parameters) |
Compute the signed amplitude of the acceleration.
|
protected double |
HarmonicParametricAcceleration.signedAmplitude(SpacecraftState state,
double[] parameters) |
Compute the signed amplitude of the acceleration.
|
protected double |
PolynomialParametricAcceleration.signedAmplitude(SpacecraftState state,
double[] parameters) |
Compute the signed amplitude of the acceleration.
|
Modifier and Type | Method | Description |
---|---|---|
org.hipparchus.geometry.euclidean.threed.Vector3D |
DragForce.acceleration(SpacecraftState s,
double[] parameters) |
Compute acceleration.
|
Modifier and Type | Method | Description |
---|---|---|
org.hipparchus.geometry.euclidean.threed.Vector3D |
HolmesFeatherstoneAttractionModel.acceleration(SpacecraftState s,
double[] parameters) |
Compute acceleration.
|
org.hipparchus.geometry.euclidean.threed.Vector3D |
NewtonianAttraction.acceleration(SpacecraftState s,
double[] parameters) |
Compute acceleration.
|
org.hipparchus.geometry.euclidean.threed.Vector3D |
OceanTides.acceleration(SpacecraftState s,
double[] parameters) |
Compute acceleration.
|
org.hipparchus.geometry.euclidean.threed.Vector3D |
Relativity.acceleration(SpacecraftState s,
double[] parameters) |
Compute acceleration.
|
org.hipparchus.geometry.euclidean.threed.Vector3D |
SolidTides.acceleration(SpacecraftState s,
double[] parameters) |
Compute acceleration.
|
org.hipparchus.geometry.euclidean.threed.Vector3D |
ThirdBodyAttraction.acceleration(SpacecraftState s,
double[] parameters) |
Compute acceleration.
|
void |
NewtonianAttraction.addContribution(SpacecraftState s,
TimeDerivativesEquations adder) |
Compute the contribution of the force model to the perturbing
acceleration.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
SmallManeuverAnalyticalModel.apply(SpacecraftState state1) |
Compute the effect of the maneuver on a spacecraft state.
|
Modifier and Type | Method | Description |
---|---|---|
org.hipparchus.geometry.euclidean.threed.Vector3D |
ConstantThrustManeuver.acceleration(SpacecraftState state,
double[] parameters) |
Compute acceleration.
|
void |
ConstantThrustManeuver.addContribution(SpacecraftState s,
TimeDerivativesEquations adder) |
Compute the contribution of the force model to the perturbing
acceleration.
|
SpacecraftState |
SmallManeuverAnalyticalModel.apply(SpacecraftState state1) |
Compute the effect of the maneuver on a spacecraft state.
|
double |
ImpulseManeuver.g(SpacecraftState s) |
Compute the value of the switching function.
|
void |
ConstantThrustManeuver.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize the force model at the start of propagation.
|
void |
ImpulseManeuver.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize event handler at the start of a propagation.
|
Constructor | Description |
---|---|
SmallManeuverAnalyticalModel(SpacecraftState state0,
org.hipparchus.geometry.euclidean.threed.Vector3D dV,
double isp) |
Build a maneuver defined in spacecraft frame.
|
SmallManeuverAnalyticalModel(SpacecraftState state0,
Frame frame,
org.hipparchus.geometry.euclidean.threed.Vector3D dV,
double isp) |
Build a maneuver defined in user-specified frame.
|
Modifier and Type | Method | Description |
---|---|---|
org.hipparchus.geometry.euclidean.threed.Vector3D |
SolarRadiationPressure.acceleration(SpacecraftState s,
double[] parameters) |
Compute acceleration.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
SpacecraftState.addAdditionalState(String name,
double... value) |
Add an additional state.
|
SpacecraftState |
AbstractPropagator.getInitialState() |
Get the propagator initial state.
|
SpacecraftState |
Propagator.getInitialState() |
Get the propagator initial state.
|
SpacecraftState |
SpacecraftState.interpolate(AbsoluteDate date,
Stream<SpacecraftState> sample) |
Get an interpolated instance.
|
SpacecraftState |
AbstractPropagator.propagate(AbsoluteDate target) |
Propagate towards a target date.
|
SpacecraftState |
Propagator.propagate(AbsoluteDate target) |
Propagate towards a target date.
|
SpacecraftState |
Propagator.propagate(AbsoluteDate start,
AbsoluteDate target) |
Propagate from a start date towards a target date.
|
SpacecraftState |
SpacecraftState.shiftedBy(double dt) |
Get a time-shifted state.
|
SpacecraftState |
FieldSpacecraftState.toSpacecraftState() |
To convert a FieldSpacecraftState instance into a SpacecraftState instance.
|
protected SpacecraftState |
AbstractPropagator.updateAdditionalStates(SpacecraftState original) |
Update state by adding all additional states.
|
Modifier and Type | Method | Description |
---|---|---|
List<SpacecraftState> |
PropagatorsParallelizer.propagate(AbsoluteDate start,
AbsoluteDate target) |
Propagate from a start date towards a target date.
|
Modifier and Type | Method | Description |
---|---|---|
void |
SpacecraftState.ensureCompatibleAdditionalStates(SpacecraftState state) |
Check if two instances have the same set of additional states available.
|
double[] |
AdditionalStateProvider.getAdditionalState(SpacecraftState state) |
Get the additional state.
|
void |
AbstractPropagator.resetInitialState(SpacecraftState state) |
Reset the propagator initial state.
|
void |
Propagator.resetInitialState(SpacecraftState state) |
Reset the propagator initial state.
|
protected SpacecraftState |
AbstractPropagator.updateAdditionalStates(SpacecraftState original) |
Update state by adding all additional states.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
SpacecraftState.interpolate(AbsoluteDate date,
Stream<SpacecraftState> sample) |
Get an interpolated instance.
|
Constructor | Description |
---|---|
FieldSpacecraftState(org.hipparchus.Field<T> field,
SpacecraftState state) |
Convert a
SpacecraftState . |
Modifier and Type | Method | Description |
---|---|---|
protected SpacecraftState |
AbstractAnalyticalPropagator.acceptStep(OrekitStepInterpolator interpolator,
AbsoluteDate target,
double epsilon) |
Accept a step, triggering events and step handlers.
|
SpacecraftState |
AdapterPropagator.DifferentialEffect.apply(SpacecraftState original) |
Apply the effect to a
spacecraft state . |
SpacecraftState |
J2DifferentialEffect.apply(SpacecraftState state1) |
Apply the effect to a
spacecraft state . |
protected SpacecraftState |
AbstractAnalyticalPropagator.basicPropagate(AbsoluteDate date) |
Propagate an orbit without any fancy features.
|
protected SpacecraftState |
AdapterPropagator.basicPropagate(AbsoluteDate date) |
Propagate an orbit without any fancy features.
|
SpacecraftState |
Ephemeris.basicPropagate(AbsoluteDate date) |
|
SpacecraftState |
AdapterPropagator.getInitialState() |
Get the propagator initial state.
|
SpacecraftState |
AggregateBoundedPropagator.getInitialState() |
|
SpacecraftState |
Ephemeris.getInitialState() |
Get the propagator initial state.
|
SpacecraftState |
AbstractAnalyticalPropagator.propagate(AbsoluteDate start,
AbsoluteDate target) |
Propagate from a start date towards a target date.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
AdapterPropagator.DifferentialEffect.apply(SpacecraftState original) |
Apply the effect to a
spacecraft state . |
SpacecraftState |
J2DifferentialEffect.apply(SpacecraftState state1) |
Apply the effect to a
spacecraft state . |
void |
AdapterPropagator.resetInitialState(SpacecraftState state) |
Reset the propagator initial state.
|
void |
AggregateBoundedPropagator.resetInitialState(SpacecraftState state) |
|
void |
EcksteinHechlerPropagator.resetInitialState(SpacecraftState state) |
Reset the propagator initial state.
|
void |
Ephemeris.resetInitialState(SpacecraftState state) |
Try (and fail) to reset the initial state.
|
void |
KeplerianPropagator.resetInitialState(SpacecraftState state) |
Reset the propagator initial state.
|
protected abstract void |
AbstractAnalyticalPropagator.resetIntermediateState(SpacecraftState state,
boolean forward) |
Reset an intermediate state.
|
protected void |
AdapterPropagator.resetIntermediateState(SpacecraftState state,
boolean forward) |
Reset an intermediate state.
|
protected void |
AggregateBoundedPropagator.resetIntermediateState(SpacecraftState state,
boolean forward) |
|
protected void |
EcksteinHechlerPropagator.resetIntermediateState(SpacecraftState state,
boolean forward) |
Reset an intermediate state.
|
protected void |
Ephemeris.resetIntermediateState(SpacecraftState state,
boolean forward) |
Reset an intermediate state.
|
protected void |
KeplerianPropagator.resetIntermediateState(SpacecraftState state,
boolean forward) |
Reset an intermediate state.
|
Constructor | Description |
---|---|
J2DifferentialEffect(SpacecraftState original,
AdapterPropagator.DifferentialEffect directEffect,
boolean applyBefore,
double referenceRadius,
double mu,
double j2) |
Simple constructor.
|
J2DifferentialEffect(SpacecraftState original,
AdapterPropagator.DifferentialEffect directEffect,
boolean applyBefore,
UnnormalizedSphericalHarmonicsProvider gravityField) |
Simple constructor.
|
Constructor | Description |
---|---|
Ephemeris(List<SpacecraftState> states,
int interpolationPoints) |
Constructor with tabulated states.
|
Ephemeris(List<SpacecraftState> states,
int interpolationPoints,
double extrapolationThreshold) |
Constructor with tabulated states.
|
Modifier and Type | Method | Description |
---|---|---|
double[] |
ClockCorrectionsProvider.getAdditionalState(SpacecraftState state) |
Get the additional state.
|
void |
GPSPropagator.resetInitialState(SpacecraftState state) |
Reset the propagator initial state.
|
protected void |
GPSPropagator.resetIntermediateState(SpacecraftState state,
boolean forward) |
Reset an intermediate state.
|
Modifier and Type | Method | Description |
---|---|---|
void |
TLEPropagator.resetInitialState(SpacecraftState state) |
Reset the propagator initial state.
|
protected void |
TLEPropagator.resetIntermediateState(SpacecraftState state,
boolean forward) |
Reset an intermediate state.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
OsculatingToMeanElementsConverter.convert() |
Convert an osculating orbit into a mean orbit, in DSST sense.
|
Modifier and Type | Method | Description |
---|---|---|
protected List<SpacecraftState> |
AbstractPropagatorConverter.getSample() |
Get the states sample.
|
Modifier and Type | Method | Description |
---|---|---|
Propagator |
AbstractPropagatorConverter.convert(List<SpacecraftState> states,
boolean positionOnly,
String... freeParameters) |
Find the propagator that minimize the mean square error for a sample of
states . |
Propagator |
AbstractPropagatorConverter.convert(List<SpacecraftState> states,
boolean positionOnly,
List<String> freeParameters) |
Find the propagator that minimize the mean square error for a sample of
states . |
Propagator |
PropagatorConverter.convert(List<SpacecraftState> states,
boolean positionOnly,
String... freeParameters) |
Find the propagator that minimize the mean square error for a sample of
states . |
Propagator |
PropagatorConverter.convert(List<SpacecraftState> states,
boolean positionOnly,
List<String> freeParameters) |
Find the propagator that minimize the mean square error for a sample of
states . |
Constructor | Description |
---|---|
OsculatingToMeanElementsConverter(SpacecraftState state,
int satelliteRevolution,
Propagator propagator,
double positionScale) |
Constructor.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
EventState.EventOccurrence.getNewState() |
Get the new state for a reset action.
|
SpacecraftState |
EventsLogger.LoggedEvent.getState() |
Get the triggering state.
|
SpacecraftState |
AbstractDetector.resetState(SpacecraftState oldState) |
Reset the state prior to continue propagation.
|
SpacecraftState |
AdapterDetector.resetState(SpacecraftState oldState) |
Reset the state prior to continue propagation.
|
default SpacecraftState |
EventDetector.resetState(SpacecraftState oldState) |
Reset the state prior to continue propagation.
|
Modifier and Type | Method | Description |
---|---|---|
ToDoubleFunction<SpacecraftState> |
FunctionalDetector.getFunction() |
Get the switching function.
|
Modifier and Type | Method | Description |
---|---|---|
double |
FunctionalDetector.GFunction.apply(SpacecraftState value) |
Deprecated.
Use
ToDoubleFunction.applyAsDouble(Object) instead. Will be
removed in next major release. |
EventState.EventOccurrence |
EventState.doEvent(SpacecraftState state) |
Notify the user's listener of the event.
|
boolean |
EnablingPredicate.eventIsEnabled(SpacecraftState state,
S eventDetector,
double g) |
Compute an event enabling function of state.
|
EventHandler.Action |
AbstractDetector.eventOccurred(SpacecraftState s,
boolean increasing) |
Handle the event.
|
EventHandler.Action |
AdapterDetector.eventOccurred(SpacecraftState s,
boolean increasing) |
Handle the event.
|
EventHandler.Action |
EventDetector.eventOccurred(SpacecraftState s,
boolean increasing) |
Handle the event.
|
abstract double |
AbstractDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
AdapterDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
AlignmentDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
AltitudeDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
AngularSeparationDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
ApsideDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
BooleanDetector.g(SpacecraftState s) |
|
double |
CircularFieldOfViewDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
DateDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
EclipseDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
ElevationDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
ElevationExtremumDetector.g(SpacecraftState s) |
Compute the value of the detection function.
|
double |
EventDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
EventEnablingPredicateFilter.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
EventShifter.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
EventSlopeFilter.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
FieldOfViewDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
FootprintOverlapDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
FunctionalDetector.g(SpacecraftState s) |
|
double |
GeographicZoneDetector.g(SpacecraftState s) |
Compute the value of the detection function.
|
double |
GroundAtNightDetector.g(SpacecraftState state) |
Compute the value of the switching function.
|
double |
GroundFieldOfViewDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
InterSatDirectViewDetector.g(SpacecraftState state) |
Compute the value of the switching function.
|
double |
LatitudeCrossingDetector.g(SpacecraftState s) |
Compute the value of the detection function.
|
double |
LatitudeExtremumDetector.g(SpacecraftState s) |
Compute the value of the detection function.
|
double |
LongitudeCrossingDetector.g(SpacecraftState s) |
Compute the value of the detection function.
|
double |
LongitudeExtremumDetector.g(SpacecraftState s) |
Compute the value of the detection function.
|
double |
NegateDetector.g(SpacecraftState s) |
|
double |
NodeDetector.g(SpacecraftState s) |
Compute the value of the switching function.
|
double |
PositionAngleDetector.g(SpacecraftState s) |
Compute the value of the detection function.
|
double |
ElevationExtremumDetector.getElevation(SpacecraftState s) |
Get the elevation value.
|
void |
AbstractDetector.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize event handler at the start of a propagation.
|
void |
AdapterDetector.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize event handler at the start of a propagation.
|
void |
BooleanDetector.init(SpacecraftState s0,
AbsoluteDate t) |
|
default void |
EventDetector.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize event handler at the start of a propagation.
|
void |
EventEnablingPredicateFilter.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize event handler at the start of a propagation.
|
void |
EventShifter.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize event handler at the start of a propagation.
|
void |
EventSlopeFilter.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize event handler at the start of a propagation.
|
void |
EventState.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize event handler at the start of a propagation.
|
void |
NegateDetector.init(SpacecraftState s0,
AbsoluteDate t) |
|
void |
PositionAngleDetector.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize event handler at the start of a propagation.
|
SpacecraftState |
AbstractDetector.resetState(SpacecraftState oldState) |
Reset the state prior to continue propagation.
|
SpacecraftState |
AdapterDetector.resetState(SpacecraftState oldState) |
Reset the state prior to continue propagation.
|
default SpacecraftState |
EventDetector.resetState(SpacecraftState oldState) |
Reset the state prior to continue propagation.
|
boolean |
EventState.tryAdvance(SpacecraftState state,
OrekitStepInterpolator interpolator) |
Try to accept the current history up to the given time.
|
Modifier and Type | Method | Description |
---|---|---|
FunctionalDetector |
FunctionalDetector.withFunction(ToDoubleFunction<SpacecraftState> newGFunction) |
Create a new event detector with a new g function, keeping all other attributes the
same.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
RecordAndContinue.Event.getState() |
Get the spacecraft's state at the event.
|
default SpacecraftState |
EventHandler.resetState(T detector,
SpacecraftState oldState) |
Reset the state prior to continue propagation.
|
SpacecraftState |
RecordAndContinue.resetState(T detector,
SpacecraftState oldState) |
Modifier and Type | Method | Description |
---|---|---|
EventHandler.Action |
ContinueOnEvent.eventOccurred(SpacecraftState s,
T detector,
boolean increasing) |
Specific implementation of the eventOccurred interface.
|
EventHandler.Action |
EventHandler.eventOccurred(SpacecraftState s,
T detector,
boolean increasing) |
eventOccurred method mirrors the same interface method as in
EventDetector
and its subclasses, but with an additional parameter that allows the calling
method to pass in an object from the detector which would have potential
additional data to allow the implementing class to determine the correct
return state. |
EventHandler.Action |
RecordAndContinue.eventOccurred(SpacecraftState s,
T detector,
boolean increasing) |
|
EventHandler.Action |
StopOnDecreasing.eventOccurred(SpacecraftState s,
T detector,
boolean increasing) |
Handle a detection event and choose what to do next.
|
EventHandler.Action |
StopOnEvent.eventOccurred(SpacecraftState s,
T detector,
boolean increasing) |
Specific implementation of the eventOccurred interface.
|
EventHandler.Action |
StopOnIncreasing.eventOccurred(SpacecraftState s,
T detector,
boolean increasing) |
Handle a detection event and choose what to do next.
|
default void |
EventHandler.init(SpacecraftState initialState,
AbsoluteDate target) |
Initialize event handler at the start of a propagation.
|
default SpacecraftState |
EventHandler.resetState(T detector,
SpacecraftState oldState) |
Reset the state prior to continue propagation.
|
SpacecraftState |
RecordAndContinue.resetState(T detector,
SpacecraftState oldState) |
Modifier and Type | Method | Description |
---|---|---|
protected SpacecraftState |
IntegratedEphemeris.basicPropagate(AbsoluteDate date) |
Propagate an orbit without any fancy features.
|
protected SpacecraftState |
AbstractIntegratedPropagator.getInitialIntegrationState() |
Get the initial state for integration.
|
SpacecraftState |
IntegratedEphemeris.getInitialState() |
Get the propagator initial state.
|
SpacecraftState |
StateMapper.mapArrayToState(double t,
double[] y,
double[] yDot,
boolean meanOnly) |
Map the raw double components to a spacecraft state.
|
abstract SpacecraftState |
StateMapper.mapArrayToState(AbsoluteDate date,
double[] y,
double[] yDot,
boolean meanOnly) |
Map the raw double components to a spacecraft state.
|
SpacecraftState |
AbstractIntegratedPropagator.propagate(AbsoluteDate target) |
Propagate towards a target date.
|
protected SpacecraftState |
AbstractIntegratedPropagator.propagate(AbsoluteDate tEnd,
boolean activateHandlers) |
Propagation with or without event detection.
|
SpacecraftState |
AbstractIntegratedPropagator.propagate(AbsoluteDate tStart,
AbsoluteDate tEnd) |
Propagate from a start date towards a target date.
|
Modifier and Type | Method | Description |
---|---|---|
protected void |
AbstractIntegratedPropagator.beforeIntegration(SpacecraftState initialState,
AbsoluteDate tEnd) |
Method called just before integration.
|
double[] |
AbstractIntegratedPropagator.MainStateEquations.computeDerivatives(SpacecraftState state) |
Compute differential equations for main state.
|
double[] |
AdditionalEquations.computeDerivatives(SpacecraftState s,
double[] pDot) |
Compute the derivatives related to the additional state parameters.
|
default void |
AbstractIntegratedPropagator.MainStateEquations.init(SpacecraftState initialState,
AbsoluteDate target) |
Initialize the equations at the start of propagation.
|
default void |
AdditionalEquations.init(SpacecraftState initialState,
AbsoluteDate target) |
Initialize the equations at the start of propagation.
|
abstract void |
StateMapper.mapStateToArray(SpacecraftState state,
double[] y,
double[] yDot) |
Map a spacecraft state to raw double components.
|
void |
IntegratedEphemeris.resetInitialState(SpacecraftState state) |
Reset the propagator initial state.
|
protected void |
IntegratedEphemeris.resetIntermediateState(SpacecraftState state,
boolean forward) |
Reset an intermediate state.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
PartialDerivativesEquations.setInitialJacobians(SpacecraftState s0) |
Set the initial value of the Jacobian with respect to state and parameter.
|
SpacecraftState |
PartialDerivativesEquations.setInitialJacobians(SpacecraftState s1,
double[][] dY1dY0,
double[][] dY1dP) |
Set the initial value of the Jacobian with respect to state and parameter.
|
SpacecraftState |
PartialDerivativesEquations.setInitialJacobians(SpacecraftState s0,
int stateDimension) |
Deprecated.
as of 9.0, replaced by
PartialDerivativesEquations.setInitialJacobians(SpacecraftState) |
Modifier and Type | Method | Description |
---|---|---|
double[] |
PartialDerivativesEquations.computeDerivatives(SpacecraftState s,
double[] pDot) |
Compute the derivatives related to the additional state parameters.
|
void |
JacobiansMapper.getParametersJacobian(SpacecraftState state,
double[][] dYdP) |
Get theJacobian with respect to parameters from a one-dimensional additional state array.
|
void |
JacobiansMapper.getStateJacobian(SpacecraftState state,
double[][] dYdY0) |
Get the Jacobian with respect to state from a one-dimensional additional state array.
|
void |
NumericalPropagator.resetInitialState(SpacecraftState state) |
Reset the propagator initial state.
|
SpacecraftState |
PartialDerivativesEquations.setInitialJacobians(SpacecraftState s0) |
Set the initial value of the Jacobian with respect to state and parameter.
|
SpacecraftState |
PartialDerivativesEquations.setInitialJacobians(SpacecraftState s1,
double[][] dY1dY0,
double[][] dY1dP) |
Set the initial value of the Jacobian with respect to state and parameter.
|
SpacecraftState |
PartialDerivativesEquations.setInitialJacobians(SpacecraftState s0,
int stateDimension) |
Deprecated.
as of 9.0, replaced by
PartialDerivativesEquations.setInitialJacobians(SpacecraftState) |
void |
NumericalPropagator.setInitialState(SpacecraftState initialState) |
Set the initial state.
|
Modifier and Type | Method | Description |
---|---|---|
SpacecraftState |
OrekitStepInterpolator.getCurrentState() |
Get the state at current grid point date.
|
SpacecraftState |
OrekitStepInterpolator.getInterpolatedState(AbsoluteDate date) |
Get the state at interpolated date.
|
SpacecraftState |
OrekitStepInterpolator.getPreviousState() |
Get the state at previous grid point date.
|
Modifier and Type | Method | Description |
---|---|---|
void |
OrekitFixedStepHandler.handleStep(SpacecraftState currentState,
boolean isLast) |
Handle the current step.
|
default void |
OrekitFixedStepHandler.init(SpacecraftState s0,
AbsoluteDate t) |
Deprecated.
as of 9.0, replaced by
OrekitFixedStepHandler.init(SpacecraftState, AbsoluteDate, double) |
default void |
OrekitFixedStepHandler.init(SpacecraftState s0,
AbsoluteDate t,
double step) |
Initialize step handler at the start of a propagation.
|
default void |
OrekitStepHandler.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize step handler at the start of a propagation.
|
void |
OrekitStepHandlerMultiplexer.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize step handler at the start of a propagation.
|
void |
OrekitStepNormalizer.init(SpacecraftState s0,
AbsoluteDate t) |
Initialize step handler at the start of a propagation.
|
OrekitStepInterpolator |
OrekitStepInterpolator.restrictStep(SpacecraftState newPreviousState,
SpacecraftState newCurrentState) |
Create a new restricted version of the instance.
|
Modifier and Type | Method | Description |
---|---|---|
default void |
MultiSatStepHandler.init(List<SpacecraftState> states0,
AbsoluteDate t) |
Initialize step handler at the start of a propagation.
|
Modifier and Type | Method | Description |
---|---|---|
static SpacecraftState |
DSSTPropagator.computeMeanState(SpacecraftState osculating,
AttitudeProvider attitudeProvider,
Collection<DSSTForceModel> forceModels) |
Conversion from osculating to mean orbit.
|
static SpacecraftState |
DSSTPropagator.computeOsculatingState(SpacecraftState mean,
AttitudeProvider attitudeProvider,
Collection<DSSTForceModel> forces) |
Conversion from mean to osculating orbit.
|
protected SpacecraftState |
DSSTPropagator.getInitialIntegrationState() |
Get the initial state for integration.
|
Modifier and Type | Method | Description |
---|---|---|
protected void |
DSSTPropagator.beforeIntegration(SpacecraftState initialState,
AbsoluteDate tEnd) |
Method called just before integration.
|
static SpacecraftState |
DSSTPropagator.computeMeanState(SpacecraftState osculating,
AttitudeProvider attitudeProvider,
Collection<DSSTForceModel> forceModels) |
Conversion from osculating to mean orbit.
|
static SpacecraftState |
DSSTPropagator.computeOsculatingState(SpacecraftState mean,
AttitudeProvider attitudeProvider,
Collection<DSSTForceModel> forces) |
Conversion from mean to osculating orbit.
|
void |
DSSTPropagator.resetInitialState(SpacecraftState state) |
Reset the initial state.
|
void |
DSSTPropagator.setInitialState(SpacecraftState initialState) |
Set the initial state with osculating orbital elements.
|
void |
DSSTPropagator.setInitialState(SpacecraftState initialState,
boolean isOsculating) |
Set the initial state.
|
Modifier and Type | Method | Description |
---|---|---|
protected abstract double[] |
AbstractGaussianContribution.getLLimits(SpacecraftState state) |
Compute the limits in L, the true longitude, for integration.
|
protected double[] |
DSSTAtmosphericDrag.getLLimits(SpacecraftState state) |
Compute the limits in L, the true longitude, for integration.
|
protected double[] |
DSSTSolarRadiationPressure.getLLimits(SpacecraftState state) |
Compute the limits in L, the true longitude, for integration.
|
double[] |
AbstractGaussianContribution.getMeanElementRate(SpacecraftState state) |
Computes the mean equinoctial elements rates dai / dt.
|
double[] |
DSSTForceModel.getMeanElementRate(SpacecraftState state) |
Computes the mean equinoctial elements rates dai / dt.
|
double[] |
DSSTTesseral.getMeanElementRate(SpacecraftState spacecraftState) |
Computes the mean equinoctial elements rates dai / dt.
|
double[] |
DSSTThirdBody.getMeanElementRate(SpacecraftState currentState) |
Computes the mean equinoctial elements rates dai / dt.
|
double[] |
DSSTZonal.getMeanElementRate(SpacecraftState spacecraftState) |
Computes the mean equinoctial elements rates dai / dt.
|
void |
AbstractGaussianContribution.updateShortPeriodTerms(SpacecraftState... meanStates) |
Update the short period terms.
|
void |
DSSTForceModel.updateShortPeriodTerms(SpacecraftState... meanStates) |
Update the short period terms.
|
void |
DSSTTesseral.updateShortPeriodTerms(SpacecraftState... meanStates) |
Update the short period terms.
|
void |
DSSTThirdBody.updateShortPeriodTerms(SpacecraftState... meanStates) |
Update the short period terms.
|
void |
DSSTZonal.updateShortPeriodTerms(SpacecraftState... meanStates) |
Update the short period terms.
|
Modifier and Type | Method | Description |
---|---|---|
double[] |
StateFunction.value(SpacecraftState state) |
Evaluate the function.
|
double[][] |
StateJacobian.value(SpacecraftState state) |
Evaluate the Jacobian of the function.
|
Copyright © 2002-2019 CS Systèmes d'information. All rights reserved.