Uses of Class
org.orekit.orbits.Orbit
-
Packages that use Orbit Package Description org.orekit.control.indirect.shooting.boundary This package provides classes relative to the boundary conditions for indirect shooting.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.files.general This package provides interfaces for orbit file representations and corresponding parsers.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 Propagationorg.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.intelsat This package provides classes to propagate Intelsat's 11 elements.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 ofSpacecraftStateinto another propagator.org.orekit.propagation.conversion.averaging This package wraps methods from various (semi)analytical models in Orekit to convert back and forth between an averaged orbital state and an osculating one.org.orekit.propagation.conversion.averaging.converters This package wraps conversions from an osculating orbit to an averaged state according to a given theory (usually via a fixed-point algorithm using the inverse conversion).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. -
-
Uses of Orbit in org.orekit.control.indirect.shooting.boundary
Methods in org.orekit.control.indirect.shooting.boundary that return Orbit Modifier and Type Method Description OrbitFixedTimeBoundaryOrbits. getInitialOrbit()Getter for the initial condition.OrbitFixedTimeBoundaryOrbits. getTerminalOrbit()Getter for the terminal condition.Constructors in org.orekit.control.indirect.shooting.boundary with parameters of type Orbit Constructor Description FixedTimeBoundaryOrbits(Orbit initialOrbit, Orbit terminalOrbit)Constructor. -
Uses of Orbit in org.orekit.estimation.iod
Methods in org.orekit.estimation.iod that return Orbit Modifier and Type Method Description OrbitIodGauss. estimate(Frame outputFrame, Vector3D obsP1, AbsoluteDate obsDate1, Vector3D los1, Vector3D obsP2, AbsoluteDate obsDate2, Vector3D los2, Vector3D obsP3, AbsoluteDate obsDate3, Vector3D los3)Estimate and orbit based on Gauss Intial Orbit Determination method.OrbitIodGauss. estimate(Frame outputFrame, AngularAzEl azEl1, AngularAzEl azEl2, AngularAzEl azEl3)Estimate and orbit based on Gauss Intial Orbit Determination method.OrbitIodGauss. estimate(Frame outputFrame, AngularRaDec raDec1, AngularRaDec raDec2, AngularRaDec raDec3)Estimate and orbit based on Gauss Intial Orbit Determination method.OrbitIodGibbs. estimate(Frame frame, Vector3D r1, AbsoluteDate date1, Vector3D r2, AbsoluteDate date2, Vector3D r3, AbsoluteDate date3)Give an initial orbit estimation, assuming Keplerian motion.OrbitIodGibbs. estimate(Frame frame, Position p1, Position p2, Position p3)Give an initial orbit estimation, assuming Keplerian motion.OrbitIodGibbs. estimate(Frame frame, PV pv1, PV pv2, PV pv3)Give an initial orbit estimation, assuming Keplerian motion.OrbitIodGooding. estimate(Frame outputFrame, Vector3D O1, Vector3D O2, Vector3D O3, Vector3D lineOfSight1, AbsoluteDate dateObs1, Vector3D lineOfSight2, AbsoluteDate dateObs2, Vector3D lineOfSight3, AbsoluteDate dateObs3, double rho1init, double rho3init)Estimate orbit from three line of sight.OrbitIodGooding. estimate(Frame outputFrame, Vector3D O1, Vector3D O2, Vector3D O3, Vector3D lineOfSight1, AbsoluteDate dateObs1, Vector3D lineOfSight2, AbsoluteDate dateObs2, Vector3D lineOfSight3, AbsoluteDate dateObs3, double rho1init, double rho3init, int nRev, boolean direction)Estimate orbit from three line of sight.OrbitIodGooding. estimate(Frame outputFrame, AngularAzEl azEl1, AngularAzEl azEl2, AngularAzEl azEl3, double rho1init, double rho3init)Estimate orbit from three angular observations.OrbitIodGooding. estimate(Frame outputFrame, AngularAzEl azEl1, AngularAzEl azEl2, AngularAzEl azEl3, double rho1init, double rho3init, int nRev, boolean direction)Estimate orbit from three angular observations.OrbitIodGooding. estimate(Frame outputFrame, AngularRaDec raDec1, AngularRaDec raDec2, AngularRaDec raDec3, double rho1init, double rho3init)Estimate orbit from three angular observations.OrbitIodGooding. estimate(Frame outputFrame, AngularRaDec raDec1, AngularRaDec raDec2, AngularRaDec raDec3, double rho1init, double rho3init, int nRev, boolean direction)Estimate orbit from three angular observations.OrbitIodLambert. estimate(Frame frame, boolean posigrade, int nRev, Vector3D p1, AbsoluteDate t1, Vector3D p2, AbsoluteDate t2)Estimate a Keplerian orbit given two position vectors and a duration.OrbitIodLambert. estimate(Frame frame, boolean posigrade, int nRev, Position p1, Position p2)Estimate an initial orbit from two position measurements.OrbitIodLambert. estimate(Frame frame, boolean posigrade, int nRev, PV pv1, PV pv2)Estimate an initial orbit from two PV measurements.OrbitIodLaplace. estimate(Frame outputFrame, AngularAzEl azEl1, AngularAzEl azEl2, AngularAzEl azEl3)Estimate the orbit from three angular observations at the same location.OrbitIodLaplace. estimate(Frame outputFrame, AngularRaDec raDec1, AngularRaDec raDec2, AngularRaDec raDec3)Estimate the orbit from three angular observations at the same location.OrbitIodLaplace. estimate(Frame outputFrame, PVCoordinates obsPva, AbsoluteDate obsDate1, Vector3D los1, AbsoluteDate obsDate2, Vector3D los2, AbsoluteDate obsDate3, Vector3D los3)Estimate orbit from three line of sight angles at the same location. -
Uses of Orbit in org.orekit.estimation.leastsquares
Methods in org.orekit.estimation.leastsquares that return Orbit Modifier and Type Method Description protected abstract OrbitAbstractBatchLSModel. configureOrbits(MatricesHarvester harvester, Propagator propagator)Configure the current estimated orbits.protected OrbitBatchLSModel. configureOrbits(MatricesHarvester harvester, Propagator propagator)Configure the current estimated orbits.protected OrbitDSSTBatchLSModel. configureOrbits(MatricesHarvester harvester, Propagator propagator)Configure the current estimated orbits.Methods in org.orekit.estimation.leastsquares with parameters of type Orbit Modifier and Type Method Description voidBatchLSObserver. 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.voidModelObserver. modelCalled(Orbit[] orbits, Map<ObservedMeasurement<?>,EstimatedMeasurement<?>> estimations)Notification callback for orbit changes. -
Uses of Orbit in org.orekit.files.general
Methods in org.orekit.files.general that return Orbit Modifier and Type Method Description protected OrbitEphemerisSegmentPropagator. propagateOrbit(AbsoluteDate date) -
Uses of Orbit in org.orekit.forces.maneuvers
Methods in org.orekit.forces.maneuvers that return Orbit Modifier and Type Method Description OrbitSmallManeuverAnalyticalModel. apply(Orbit orbit1)Compute the effect of the maneuver on an orbit.Methods in org.orekit.forces.maneuvers with parameters of type Orbit Modifier and Type Method Description OrbitSmallManeuverAnalyticalModel. apply(Orbit orbit1)Compute the effect of the maneuver on an orbit.voidSmallManeuverAnalyticalModel. getJacobian(Orbit orbit1, PositionAngleType positionAngleType, double[][] jacobian)Compute the Jacobian of the orbit with respect to maneuver parameters. -
Uses of Orbit in org.orekit.models.earth.tessellation
Constructors in org.orekit.models.earth.tessellation with parameters of type Orbit Constructor Description AlongTrackAiming(OneAxisEllipsoid ellipsoid, Orbit orbit, boolean isAscending)Simple constructor. -
Uses of Orbit in org.orekit.orbits
Classes in org.orekit.orbits with type parameters of type Orbit Modifier and Type Class Description classWalkerConstellationSlot<O extends Orbit>Container for one satellite slot in aWalker constellation.Subclasses of Orbit in org.orekit.orbits Modifier and Type Class Description classCartesianOrbitThis class holds Cartesian orbital parameters.classCircularOrbitThis class handles circular orbital parameters.classEquinoctialOrbitThis class handles equinoctial orbital parameters, which can support both circular and equatorial orbits.classKeplerianOrbitThis class handles traditional Keplerian orbital parameters.Methods in org.orekit.orbits with type parameters of type Orbit Modifier and Type Method Description <O extends Orbit>
WalkerConstellationSlot<O>WalkerConstellation. buildReferenceSlot(O referenceOrbit)Create the reference slot, which is satellite 0 in plane 0.<O extends Orbit>
List<List<WalkerConstellationSlot<O>>>WalkerConstellation. buildRegularSlots(O referenceOrbit)Create the regular slots.<O extends Orbit>
WalkerConstellationSlot<O>WalkerConstellation. buildSlot(WalkerConstellationSlot<O> existingSlot, int plane, double satellite)Create one offset slot from an already existing slot.Methods in org.orekit.orbits that return Orbit Modifier and Type Method Description abstract OrbitOrbitType. convertType(Orbit orbit)Convert an orbit to the instance type.OrbitAbstractOrbitInterpolator. interpolate(AbsoluteDate interpolationDate, Collection<Orbit> sample)Get an interpolated instance.protected OrbitOrbitBlender. interpolate(AbstractTimeInterpolator.InterpolationData interpolationData)Interpolate instance from given interpolation data.protected OrbitOrbitHermiteInterpolator. interpolate(AbstractTimeInterpolator.InterpolationData interpolationData)Interpolate instance from given interpolation data.abstract OrbitOrbitType. mapArrayToOrbit(double[] array, double[] arrayDot, PositionAngleType type, AbsoluteDate date, double mu, Frame frame)Convert state array to orbital parameters.abstract OrbitOrbitType. normalize(Orbit orbit, Orbit reference)Normalize one orbit with respect to a reference one.abstract OrbitOrbit. shiftedBy(double dt)Get a time-shifted orbit.abstract OrbitFieldOrbit. toOrbit()Transforms the FieldOrbit instance into an Orbit instance.Methods in org.orekit.orbits with parameters of type Orbit Modifier and Type Method Description abstract <T extends CalculusFieldElement<T>>
FieldOrbit<T>OrbitType. convertToFieldOrbit(Field<T> field, Orbit orbit)Convert an orbit to the "Fielded" instance type.abstract OrbitOrbitType. convertType(Orbit orbit)Convert an orbit to the instance type.abstract ParameterDriversListOrbitType. getDrivers(double dP, Orbit orbit, PositionAngleType type)Get parameters drivers initialized from a reference orbit.abstract voidOrbitType. mapOrbitToArray(Orbit orbit, PositionAngleType type, double[] stateVector, double[] stateVectorDot)Convert orbit to state array.abstract OrbitOrbitType. 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.Method parameters in org.orekit.orbits with type arguments of type Orbit Modifier and Type Method Description static voidAbstractOrbitInterpolator. checkOrbitsConsistency(Collection<Orbit> sample)Check orbits consistency by comparing their gravitational parameters µ.OrbitAbstractOrbitInterpolator. interpolate(AbsoluteDate interpolationDate, Collection<Orbit> sample)Get an interpolated instance.Constructors in org.orekit.orbits with parameters of type Orbit Constructor 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(Field<T> field, Orbit op)Constructor from Field and Orbit.FieldCircularOrbit(Field<T> field, Orbit op)Constructor from Field and Orbit.FieldEquinoctialOrbit(Field<T> field, Orbit op)Constructor from Field and Orbit.FieldKeplerianOrbit(Field<T> field, Orbit op)Constructor from Field and Orbit.KeplerianOrbit(Orbit op)Constructor from any kind of orbital parameters. -
Uses of Orbit in org.orekit.propagation
Methods in org.orekit.propagation that return Orbit Modifier and Type Method Description OrbitSpacecraftState. getOrbit()Get the current orbit.protected OrbitAbstractStateCovarianceInterpolator. interpolateOrbit(AbsoluteDate interpolationDate, List<TimeStampedPair<Orbit,StateCovariance>> neighborList)Interpolate orbit at given interpolation date.Methods in org.orekit.propagation that return types with arguments of type Orbit Modifier and Type Method Description protected TimeStampedPair<Orbit,StateCovariance>AbstractStateCovarianceInterpolator. expressCovarianceInDesiredOutput(Orbit interpolatedOrbit, StateCovariance covarianceInOrbitFrame)Express covariance in output configuration defined at this instance construction.TimeInterpolator<Orbit>AbstractStateCovarianceInterpolator. getOrbitInterpolator()Get orbit interpolator.Optional<TimeInterpolator<Orbit>>SpacecraftStateInterpolator. getOrbitInterpolator()Get orbit interpolator.TimeStampedPair<Orbit,StateCovariance>AbstractStateCovarianceInterpolator. interpolate(AbstractTimeInterpolator.InterpolationData interpolationData)Interpolate orbit and associated covariance.Methods in org.orekit.propagation with parameters of type Orbit Modifier and Type Method Description StateCovarianceStateCovariance. changeCovarianceFrame(Orbit orbit, Frame frameOut)Get the covariance in the output frame.StateCovarianceStateCovariance. changeCovarianceFrame(Orbit orbit, LOF lofOut)Get the covariance in a given local orbital frame.StateCovarianceStateCovariance. changeCovarianceType(Orbit orbit, OrbitType outOrbitType, PositionAngleType outAngleType)Get the covariance matrix in another orbit type.protected abstract StateCovarianceAbstractStateCovarianceInterpolator. computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates, Orbit interpolatedOrbit)Compute the interpolated covariance expressed in the interpolated orbit frame.protected StateCovarianceStateCovarianceBlender. computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates, Orbit interpolatedOrbit)Compute the interpolated covariance expressed in the interpolated orbit frame.protected StateCovarianceStateCovarianceKeplerianHermiteInterpolator. 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 RealMatrixStateCovariance. getStm(Orbit initialOrbit, double dt)Get the state transition matrix considering Keplerian contribution only.StateCovarianceStateCovariance. shiftedBy(Orbit orbit, double dt)Get a time-shifted covariance matrix.Method parameters in org.orekit.propagation with type arguments of type Orbit Modifier and Type Method Description protected abstract StateCovarianceAbstractStateCovarianceInterpolator. computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates, Orbit interpolatedOrbit)Compute the interpolated covariance expressed in the interpolated orbit frame.protected StateCovarianceStateCovarianceBlender. computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates, Orbit interpolatedOrbit)Compute the interpolated covariance expressed in the interpolated orbit frame.protected StateCovarianceStateCovarianceKeplerianHermiteInterpolator. computeInterpolatedCovarianceInOrbitFrame(List<TimeStampedPair<Orbit,StateCovariance>> uncertainStates, Orbit interpolatedOrbit)Compute the interpolated covariance expressed in the interpolated orbit frame.protected OrbitAbstractStateCovarianceInterpolator. interpolateOrbit(AbsoluteDate interpolationDate, List<TimeStampedPair<Orbit,StateCovariance>> neighborList)Interpolate orbit at given interpolation date.Constructors in org.orekit.propagation with parameters of type Orbit Constructor Description SpacecraftState(Orbit orbit)Build a spacecraft state from orbit only.SpacecraftState(Orbit orbit, double mass)Create a new instance from orbit and mass.SpacecraftState(Orbit orbit, double mass, DoubleArrayDictionary additional)Create a new instance from orbit, mass and additional states.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, 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, DoubleArrayDictionary additional)Build a spacecraft state from orbit, attitude and additional states.SpacecraftState(Orbit orbit, DoubleArrayDictionary additional)Build a spacecraft state from orbit and additional states.Constructor parameters in org.orekit.propagation with type arguments of type Orbit Constructor 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(int interpolationPoints, double extrapolationThreshold, Frame outputFrame, TimeInterpolator<Orbit> orbitInterpolator, TimeInterpolator<AbsolutePVCoordinates> absPVAInterpolator, TimeInterpolator<TimeStampedDouble> massInterpolator, TimeInterpolator<Attitude> attitudeInterpolator, TimeInterpolator<TimeStampedDouble> additionalStateInterpolator)Constructor.SpacecraftStateInterpolator(Frame outputFrame, TimeInterpolator<Orbit> orbitInterpolator, TimeInterpolator<AbsolutePVCoordinates> absPVAInterpolator, TimeInterpolator<TimeStampedDouble> massInterpolator, TimeInterpolator<Attitude> attitudeInterpolator, TimeInterpolator<TimeStampedDouble> additionalStateInterpolator)Deprecated.using this constructor may throw an exception if any given interpolator does not useAbstractTimeInterpolator.DEFAULT_INTERPOLATION_POINTSandAbstractTimeInterpolator.DEFAULT_EXTRAPOLATION_THRESHOLD_SEC.StateCovarianceBlender(SmoothStepFactory.SmoothStepFunction blendingFunction, TimeInterpolator<Orbit> orbitInterpolator, Frame outFrame, OrbitType outOrbitType, PositionAngleType outPositionAngleType)Constructor.StateCovarianceBlender(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, Frame outFrame, OrbitType outOrbitType, PositionAngleType outPositionAngleType)Constructor using an output frame and : Default number of interpolation points ofDEFAULT_INTERPOLATION_POINTSUse 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_SECs) 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, CartesianDerivativesFilter filter, Frame outFrame, OrbitType outOrbitType, PositionAngleType outPositionAngleType)Constructor using an output frame and : Default extrapolation threshold value (DEFAULT_EXTRAPOLATION_THRESHOLD_SECs) 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(TimeInterpolator<Orbit> orbitInterpolator, Frame outFrame, OrbitType outOrbitType, PositionAngleType outPositionAngleType)Constructor using an output frame and : Default number of interpolation points ofDEFAULT_INTERPOLATION_POINTSDefault extrapolation threshold value (DEFAULT_EXTRAPOLATION_THRESHOLD_SECs) 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 ofDEFAULT_INTERPOLATION_POINTSDefault extrapolation threshold value (DEFAULT_EXTRAPOLATION_THRESHOLD_SECs) 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). -
Uses of Orbit in org.orekit.propagation.analytical
Methods in org.orekit.propagation.analytical that return Orbit Modifier and Type Method Description OrbitJ2DifferentialEffect. apply(Orbit orbit1)Compute the effect of the maneuver on an orbit.protected abstract OrbitAbstractAnalyticalPropagator. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date.protected OrbitAdapterPropagator. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date.protected OrbitAggregateBoundedPropagator. propagateOrbit(AbsoluteDate date)protected OrbitEphemeris. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date.protected OrbitKeplerianPropagator. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date.Methods in org.orekit.propagation.analytical that return types with arguments of type Orbit Modifier and Type Method Description Optional<TimeInterpolator<TimeStampedPair<Orbit,StateCovariance>>>Ephemeris. getCovarianceInterpolator()Get covariance interpolator.Methods in org.orekit.propagation.analytical with parameters of type Orbit Modifier and Type Method Description OrbitJ2DifferentialEffect. apply(Orbit orbit1)Compute the effect of the maneuver on an orbit.static KeplerianOrbitBrouwerLyddanePropagator. 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 KeplerianOrbitBrouwerLyddanePropagator. computeMeanOrbit(Orbit osculating, UnnormalizedSphericalHarmonicsProvider provider, UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics, double M2Value)Conversion from osculating to mean orbit.static KeplerianOrbitBrouwerLyddanePropagator. computeMeanOrbit(Orbit osculating, UnnormalizedSphericalHarmonicsProvider provider, UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics, double M2Value, double epsilon, int maxIterations)Conversion from osculating to mean orbit.static CircularOrbitEcksteinHechlerPropagator. 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 CircularOrbitEcksteinHechlerPropagator. computeMeanOrbit(Orbit osculating, UnnormalizedSphericalHarmonicsProvider provider, UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics)Conversion from osculating to mean orbit.static CircularOrbitEcksteinHechlerPropagator. computeMeanOrbit(Orbit osculating, UnnormalizedSphericalHarmonicsProvider provider, UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics harmonics, double epsilon, int maxIterations)Conversion from osculating to mean orbit.Constructors in org.orekit.propagation.analytical with parameters of type Orbit Constructor Description 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, 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 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, double mass, UnnormalizedSphericalHarmonicsProvider provider, PropagationType initialType, double M2)Build a propagator from orbit, attitude provider, mass and potential provider.BrouwerLyddanePropagator(Orbit initialOrbit, AttitudeProvider attitudeProv, UnnormalizedSphericalHarmonicsProvider provider, double M2)Build a propagator from orbit, attitude provider 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, 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, 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 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, double mass, UnnormalizedSphericalHarmonicsProvider provider, PropagationType initialType)Build a propagator from orbit, attitude provider, mass and potential provider.EcksteinHechlerPropagator(Orbit initialOrbit, AttitudeProvider attitudeProv, UnnormalizedSphericalHarmonicsProvider provider)Build a propagator from orbit, attitude provider 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, double mu)Build a propagator from orbit and central attraction coefficient μ.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. -
Uses of Orbit in org.orekit.propagation.analytical.gnss
Methods in org.orekit.propagation.analytical.gnss that return Orbit Modifier and Type Method Description protected OrbitGLONASSAnalyticalPropagator. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date.protected OrbitGNSSPropagator. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date.protected OrbitSBASPropagator. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date. -
Uses of Orbit in org.orekit.propagation.analytical.intelsat
Methods in org.orekit.propagation.analytical.intelsat that return Orbit Modifier and Type Method Description protected OrbitIntelsatElevenElementsPropagator. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date. -
Uses of Orbit in org.orekit.propagation.analytical.tle
Methods in org.orekit.propagation.analytical.tle that return Orbit Modifier and Type Method Description protected OrbitTLEPropagator. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date. -
Uses of Orbit in org.orekit.propagation.conversion
Methods in org.orekit.propagation.conversion that return Orbit Modifier and Type Method Description protected OrbitAbstractPropagatorBuilder. createInitialOrbit()Build an initial orbit using the current selected parameters.Methods in org.orekit.propagation.conversion with parameters of type Orbit Modifier and Type Method Description AbstractFieldIntegrator<T>AdamsBashforthFieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorAdamsBashforthIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>AdamsMoultonFieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorAdamsMoultonIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>ClassicalRungeKuttaFieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorClassicalRungeKuttaIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>DormandPrince54FieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorDormandPrince54IntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>DormandPrince853FieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorDormandPrince853IntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>EulerFieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorEulerIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>FieldODEIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>GillFieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorGillIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorGraggBulirschStoerIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>HighamHall54FieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorHighamHall54IntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>LutherFieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorLutherIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>MidpointFieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorMidpointIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorODEIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractFieldIntegrator<T>ThreeEighthesFieldIntegratorBuilder. buildIntegrator(Field<T> field, Orbit orbit, OrbitType orbitType)Build a first order integrator.AbstractIntegratorThreeEighthesIntegratorBuilder. buildIntegrator(Orbit orbit, OrbitType orbitType)Build a first order integrator.protected double[][]AbstractVariableStepFieldIntegratorBuilder. getTolerances(Orbit orbit, OrbitType orbitType)Computes tolerances.protected double[][]AbstractVariableStepIntegratorBuilder. getTolerances(Orbit orbit, OrbitType orbitType)Computes tolerances.voidAbstractPropagatorBuilder. resetOrbit(Orbit newOrbit)Reset the orbit in the propagator builder.voidDSSTPropagatorBuilder. resetOrbit(Orbit newOrbit, PropagationType orbitType)Reset the orbit in the propagator builder.voidPropagatorBuilder. resetOrbit(Orbit newOrbit)Reset the orbit in the propagator builder.Constructors in org.orekit.propagation.conversion with parameters of type Orbit Constructor Description AbstractAnalyticalPropagatorBuilder(Orbit templateOrbit, PositionAngleType positionAngleType, double positionScale, boolean addDriverForCentralAttraction, AttitudeProvider attitudeProvider, double initialMass)Build a new instance.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.AbstractPropagatorBuilder(Orbit templateOrbit, PositionAngleType positionAngleType, double positionScale, boolean addDriverForCentralAttraction, AttitudeProvider attitudeProvider, double initialMass)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, double M2)Build a new instance.BrouwerLyddanePropagatorBuilder(Orbit templateOrbit, UnnormalizedSphericalHarmonicsProvider provider, PositionAngleType positionAngleType, double positionScale, AttitudeProvider attitudeProvider, 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. -
Uses of Orbit in org.orekit.propagation.conversion.averaging
Methods in org.orekit.propagation.conversion.averaging that return Orbit Modifier and Type Method Description OrbitAveragedOrbitalState. toOsculatingOrbit()Convert instance to an osculating orbit.OrbitBrouwerLyddaneOrbitalState. toOsculatingOrbit()Convert instance to an osculating orbit.OrbitDSST6X0OrbitalState. toOsculatingOrbit()Convert instance to an osculating orbit.OrbitEcksteinHechlerOrbitalState. toOsculatingOrbit()Convert instance to an osculating orbit.OrbitSGP4OrbitalState. toOsculatingOrbit()Convert instance to an osculating orbit. -
Uses of Orbit in org.orekit.propagation.conversion.averaging.converters
Methods in org.orekit.propagation.conversion.averaging.converters with parameters of type Orbit Modifier and Type Method Description TOsculatingToAveragedConverter. convertToAveraged(Orbit osculatingOrbit)Convert osculating orbit to averaged orbital state according to underlying theory.BrouwerLyddaneOrbitalStateOsculatingToBrouwerLyddaneConverter. convertToAveraged(Orbit osculatingOrbit)Convert osculating orbit to averaged orbital state according to underlying theory.DSST6X0OrbitalStateOsculatingToDSST6X0Converter. convertToAveraged(Orbit osculatingOrbit)Convert osculating orbit to averaged orbital state according to underlying theory.EcksteinHechlerOrbitalStateOsculatingToEcksteinHechlerConverter. convertToAveraged(Orbit osculatingOrbit)Convert osculating orbit to averaged orbital state according to underlying theory.SGP4OrbitalStateOsculatingToSGP4Converter. convertToAveraged(Orbit osculatingOrbit)Convert osculating orbit to averaged orbital state according to underlying theory. -
Uses of Orbit in org.orekit.propagation.events
Constructors in org.orekit.propagation.events with parameters of type Orbit Constructor 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. -
Uses of Orbit in org.orekit.propagation.integration
Methods in org.orekit.propagation.integration that return Orbit Modifier and Type Method Description protected OrbitIntegratedEphemeris. propagateOrbit(AbsoluteDate date)Extrapolate an orbit up to a specific target date. -
Uses of Orbit in org.orekit.propagation.numerical
Methods in org.orekit.propagation.numerical with parameters of type Orbit Modifier and Type Method 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. -
Uses of Orbit in org.orekit.propagation.semianalytical.dsst
Methods in org.orekit.propagation.semianalytical.dsst with parameters of type Orbit Modifier and Type Method 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. -
Uses of Orbit in org.orekit.propagation.semianalytical.dsst.forces
Methods in org.orekit.propagation.semianalytical.dsst.forces with parameters of type Orbit Modifier and Type Method Description double[]AbstractGaussianContribution.GaussianShortPeriodicCoefficients. value(Orbit meanOrbit)Evaluate the contributions of the short period terms.double[]ShortPeriodTerms. value(Orbit meanOrbit)Evaluate the contributions of the short period terms. -
Uses of Orbit in org.orekit.propagation.semianalytical.dsst.utilities
Methods in org.orekit.propagation.semianalytical.dsst.utilities that return Orbit Modifier and Type Method Description OrbitAuxiliaryElements. getOrbit()Get the orbit.Constructors in org.orekit.propagation.semianalytical.dsst.utilities with parameters of type Orbit Constructor Description AuxiliaryElements(Orbit orbit, int retrogradeFactor)Simple constructor. -
Uses of Orbit in org.orekit.ssa.collision.shorttermencounter.probability.twod
Methods in org.orekit.ssa.collision.shorttermencounter.probability.twod that return Orbit Modifier and Type Method Description protected OrbitAbstractShortTermEncounter2DPOCMethod. getObjectOrbitFromCdm(CdmRelativeMetadata cdmRelativeMetadata, CdmData cdmData, CdmMetadata cdmMetadata, DataContext cdmDataContext)Extract collision object spacecraft state from givenConjunction Data Messagedata.OrbitShortTermEncounter2DDefinition. getOtherAtTCA()Get other's orbit at time of closest approach.OrbitShortTermEncounter2DDefinition. getReferenceAtTCA()Get reference's orbit at time of closest approach.Methods in org.orekit.ssa.collision.shorttermencounter.probability.twod with parameters of type Orbit Modifier and Type Method Description ProbabilityOfCollisionAbstractShortTermEncounter1DNumerical2DPOCMethod. compute(Orbit primaryAtTCA, StateCovariance primaryCovariance, double primaryRadius, Orbit secondaryAtTCA, StateCovariance secondaryCovariance, double secondaryRadius, UnivariateIntegrator customIntegrator, int customMaxNbOfEval, double zeroThreshold)Compute the probability of collision using parameters necessary for creating acollision definitioninstance.ProbabilityOfCollisionAbstractShortTermEncounter2DPOCMethod. compute(Orbit primaryAtTCA, StateCovariance primaryCovariance, Orbit secondaryAtTCA, StateCovariance secondaryCovariance, double combinedRadius, double zeroThreshold)Compute the probability of collision using parameters necessary for creating acollision definitioninstance.default ProbabilityOfCollisionShortTermEncounter2DPOCMethod. compute(Orbit primaryAtTCA, StateCovariance primaryCovariance, double primaryRadius, Orbit secondaryAtTCA, StateCovariance secondaryCovariance, double secondaryRadius)Compute the probability of collision using parameters necessary for creating acollision definitioninstance.default ProbabilityOfCollisionShortTermEncounter2DPOCMethod. compute(Orbit primaryAtTCA, StateCovariance primaryCovariance, Orbit secondaryAtTCA, StateCovariance secondaryCovariance, double combinedRadius)Compute the probability of collision using parameters necessary for creating acollision definitioninstance.ProbabilityOfCollisionShortTermEncounter2DPOCMethod. compute(Orbit primaryAtTCA, StateCovariance primaryCovariance, Orbit secondaryAtTCA, StateCovariance secondaryCovariance, double combinedRadius, double zeroThreshold)Compute the probability of collision using parameters necessary for creating acollision definitioninstance.Constructors in org.orekit.ssa.collision.shorttermencounter.probability.twod with parameters of type Orbit Constructor 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. -
Uses of Orbit in org.orekit.utils
Methods in org.orekit.utils with parameters of type Orbit Modifier and Type Method Description static <T extends CalculusFieldElement<T>>
FieldOrbit<T>Fieldifier. fieldify(Field<T> field, Orbit orbit)Deprecated.
-