Uses of Class
org.orekit.orbits.Orbit

Packages that use Orbit
fr.cnes.sirius.patrius.guidance   
fr.cnes.sirius.patrius.propagation   
fr.cnes.sirius.patrius.propagation.precomputed.multi   
fr.cnes.sirius.patrius.stela.forces.gravity   
fr.cnes.sirius.patrius.stela.orbits   
fr.cnes.sirius.patrius.stela.propagation.data   
org.orekit.attitudes This package provides classes to represent simple attitudes. 
org.orekit.forces.maneuvers This package provides models of simple maneuvers. 
org.orekit.orbits This package provides classes to represent orbits. 
org.orekit.propagation This package provides tools to propagate orbital states with different methods. 
org.orekit.propagation.analytical   
org.orekit.propagation.analytical.covariance   
org.orekit.propagation.analytical.tle This package provides classes to read and extrapolate tle's. 
org.orekit.propagation.analytical.twod   
org.orekit.propagation.events This package provides interfaces and classes dealing with events occurring during propagation. 
org.orekit.propagation.numerical   
org.orekit.propagation.precomputed   
org.orekit.time This independent package provides classes to handle epochs, time scales, and to compare instants together. 
 

Uses of Orbit in fr.cnes.sirius.patrius.guidance
 

Methods in fr.cnes.sirius.patrius.guidance with parameters of type Orbit
 Attitude GuidanceProfile.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 

Uses of Orbit in fr.cnes.sirius.patrius.propagation
 

Methods in fr.cnes.sirius.patrius.propagation that return Orbit
protected  Orbit PVCoordinatePropagator.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
 

Uses of Orbit in fr.cnes.sirius.patrius.propagation.precomputed.multi
 

Methods in fr.cnes.sirius.patrius.propagation.precomputed.multi that return Orbit
protected  Orbit MultiIntegratedEphemeris.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
 

Uses of Orbit in fr.cnes.sirius.patrius.stela.forces.gravity
 

Methods in fr.cnes.sirius.patrius.stela.forces.gravity with parameters of type Orbit
 void TesseralQuad.updateEccentricityInterval(Orbit orbit)
          Update eccentricity interval [ec - Δe; ec + Δe].
 void StelaTesseralAttraction.updateQuads(Orbit orbit)
          Compute quads (n, m, p, q).
 

Constructors in fr.cnes.sirius.patrius.stela.forces.gravity with parameters of type Orbit
TesseralQuad(PotentialCoefficientsProvider provider, int coefN, int coefM, int coefP, int coefQ, Orbit orbit)
          Constructor.
 

Uses of Orbit in fr.cnes.sirius.patrius.stela.orbits
 

Subclasses of Orbit in fr.cnes.sirius.patrius.stela.orbits
 class StelaEquinoctialOrbit
          This class handles Stela equinoctial orbital parameters, which can support both circular and equatorial orbits.
 

Methods in fr.cnes.sirius.patrius.stela.orbits that return Orbit
 Orbit StelaEquinoctialOrbit.interpolate(AbsoluteDate date, Collection<Orbit> sample)
          Get an interpolated instance.
protected  Orbit StelaEquinoctialOrbit.orbitShiftedBy(double dt)
           
 

Method parameters in fr.cnes.sirius.patrius.stela.orbits with type arguments of type Orbit
 Orbit StelaEquinoctialOrbit.interpolate(AbsoluteDate date, Collection<Orbit> sample)
          Get an interpolated instance.
 

Constructors in fr.cnes.sirius.patrius.stela.orbits with parameters of type Orbit
StelaEquinoctialOrbit(Orbit op)
          Constructor from any kind of orbital parameters with correction when inclination is close to 180°
StelaEquinoctialOrbit(Orbit op, boolean isCorrectedIn)
          Constructor from any kind of orbital parameters.
 

Uses of Orbit in fr.cnes.sirius.patrius.stela.propagation.data
 

Methods in fr.cnes.sirius.patrius.stela.propagation.data that return Orbit
 Orbit TimeDerivativeData.getOrbit()
          Returns the orbit.
 

Constructors in fr.cnes.sirius.patrius.stela.propagation.data with parameters of type Orbit
TimeDerivativeData(Orbit aOrbit, double[] aMeanMotion, double[][] aMeanMotionSTM, Map<StelaForceModel,double[]> aDerivatives, Map<StelaForceModel,double[][]> aDerivativesSTM)
          Constructor.
 

Uses of Orbit in org.orekit.attitudes
 

Methods in org.orekit.attitudes with parameters of type Orbit
 Attitude AbstractAttitudeLaw.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudeLawLeg.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 Attitude RelativeTabulatedAttitudeLaw.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudeLegLaw.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudeProvider.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 Attitude TabulatedAttitude.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 Attitude AbstractSlew.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudeLegsSequence.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 Attitude RelativeTabulatedAttitudeLeg.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudesSequence.getAttitude(Orbit orbit)
          Compute the attitude corresponding to an orbital state.
 

Uses of Orbit in org.orekit.forces.maneuvers
 

Methods in org.orekit.forces.maneuvers that return Orbit
 Orbit SmallManeuverAnalyticalModel.apply(Orbit orbit1)
          Compute the effect of the maneuver on an orbit.
 

Methods in org.orekit.forces.maneuvers with parameters of type Orbit
 Orbit SmallManeuverAnalyticalModel.apply(Orbit orbit1)
          Compute the effect of the maneuver on an orbit.
 void SmallManeuverAnalyticalModel.getJacobian(Orbit orbit1, PositionAngle positionAngle, double[][] jacobian)
          Compute the Jacobian of the orbit with respect to maneuver parameters.
 

Uses of Orbit in org.orekit.orbits
 

Subclasses of Orbit in org.orekit.orbits
 class ApsisOrbit
          This class handles periapsis/apoapsis parameters.
 class CartesianOrbit
          This class holds cartesian orbital parameters.
 class CircularOrbit
          This class handles circular orbital parameters.
 class EquatorialOrbit
          This class handles non circular equatorial orbital parameters.
 class EquinoctialOrbit
          This class handles equinoctial orbital parameters, which can support both circular and equatorial orbits.
 class KeplerianOrbit
          This class handles traditional keplerian orbital parameters.
 

Methods in org.orekit.orbits that return Orbit
abstract  Orbit OrbitType.convertOrbit(Orbit initOrbit, Frame frame)
          Convert an orbit from a given orbit type to an other in a wished frame.
abstract  Orbit OrbitType.convertType(Orbit orbit)
          Convert an orbit to the instance type.
abstract  Orbit OrbitType.mapArrayToOrbit(double[] array, PositionAngle type, AbsoluteDate date, double mu, Frame frame)
          Convert state array to orbital parameters.
protected abstract  Orbit Orbit.orbitShiftedBy(double dt)
          Get a time-shifted orbit.
 Orbit Orbit.shiftedBy(double dt)
          Call the method orbitShiftedBy(double) implemented in inherited classes of Orbit.
 

Methods in org.orekit.orbits with parameters of type Orbit
abstract  Orbit OrbitType.convertOrbit(Orbit initOrbit, Frame frame)
          Convert an orbit from a given orbit type to an other in a wished frame.
abstract  Orbit OrbitType.convertType(Orbit orbit)
          Convert an orbit to the instance type.
abstract  void OrbitType.mapOrbitToArray(Orbit orbit, PositionAngle type, double[] stateVector)
          Convert orbit to state array.
 

Method parameters in org.orekit.orbits with type arguments of type Orbit
 CircularOrbit CircularOrbit.interpolate(AbsoluteDate date, Collection<Orbit> sample)
          Get an interpolated instance.
 KeplerianOrbit KeplerianOrbit.interpolate(AbsoluteDate date, Collection<Orbit> sample)
          Get an interpolated instance.
 EquatorialOrbit EquatorialOrbit.interpolate(AbsoluteDate date, Collection<Orbit> sample)
          Get an interpolated instance.
 EquinoctialOrbit EquinoctialOrbit.interpolate(AbsoluteDate date, Collection<Orbit> sample)
          Get an interpolated instance.
 ApsisOrbit ApsisOrbit.interpolate(AbsoluteDate date, Collection<Orbit> sample)
          Get an interpolated instance.
 CartesianOrbit CartesianOrbit.interpolate(AbsoluteDate date, Collection<Orbit> sample)
          Get an interpolated instance.
 

Constructors in org.orekit.orbits with parameters of type Orbit
ApsisOrbit(Orbit op)
          Constructor from any kind of orbital parameters.
CartesianOrbit(Orbit op)
          Constructor from any kind of orbital parameters.
CircularOrbit(Orbit op)
          Constructor from any kind of orbital parameters.
EquatorialOrbit(Orbit op)
          Constructor from any kind of orbital parameters.
EquinoctialOrbit(Orbit op)
          Constructor from any kind of orbital parameters.
KeplerianOrbit(Orbit op)
          Constructor from any kind of orbital parameters.
 

Uses of Orbit in org.orekit.propagation
 

Methods in org.orekit.propagation that return Orbit
 Orbit SpacecraftState.getOrbit()
          Gets the current orbit.
 Orbit MeanOsculatingElementsProvider.mean2osc(Orbit orbit)
          Convert provided mean orbit into osculating elements.
 Orbit MeanOsculatingElementsProvider.osc2mean(Orbit orbit)
          Convert provided osculating orbit into mean elements.
 Orbit MeanOsculatingElementsProvider.propagateMeanOrbit(AbsoluteDate date)
          Propagate mean orbit until provided date.
protected  Orbit AnalyticalIntegratedEphemeris.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
protected abstract  Orbit AbstractPropagator.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
 

Methods in org.orekit.propagation with parameters of type Orbit
 Orbit MeanOsculatingElementsProvider.mean2osc(Orbit orbit)
          Convert provided mean orbit into osculating elements.
 Orbit MeanOsculatingElementsProvider.osc2mean(Orbit orbit)
          Convert provided osculating orbit into mean elements.
 SpacecraftState SpacecraftState.updateOrbit(Orbit newOrbit)
          Update the orbit.
 

Constructors in org.orekit.propagation with parameters of type Orbit
SpacecraftState(Orbit orbit)
          Build a spacecraft state from orbit only.
SpacecraftState(Orbit orbit, Attitude attitude)
          Build a spacecraft state from orbit and a single attitude.
SpacecraftState(Orbit orbit, Attitude attForces, Attitude attEvents)
          Build a spacecraft state from orbit, attitude for forces and events computation.
SpacecraftState(Orbit orbit, Attitude attForces, Attitude attEvents, Map<String,double[]> addStates)
          Build a spacecraft state from orbit, attitude for forces and events computation and additional states map.
SpacecraftState(Orbit orbit, Attitude attForces, Attitude attEvents, MassProvider massProvider)
          Build a spacecraft state from orbit, attitude for forces and events computation and mass provider.
SpacecraftState(Orbit orbit, Attitude attForces, Attitude attEvents, MassProvider massProvider, Map<String,double[]> additionalStates)
          Build a spacecraft state from orbit, attitude for forces and events computation, mass provider and additional states map.
SpacecraftState(Orbit orbit, Attitude attitude, MassProvider massProvider)
          Build a spacecraft state from orbit, attitude and mass provider.
SpacecraftState(Orbit orbit, MassProvider massProvider)
          Create a new instance from orbit and mass provider.
 

Uses of Orbit in org.orekit.propagation.analytical
 

Fields in org.orekit.propagation.analytical declared as Orbit
protected  Orbit AbstractLyddanePropagator.secularOrbitIn
          Secular orbit.
 

Methods in org.orekit.propagation.analytical that return Orbit
 Orbit J2DifferentialEffect.apply(Orbit orbit1)
          Compute the effect of the maneuver on an orbit.
 Orbit EcksteinHechlerPropagator.computeMeanOrbit(Orbit osculating)
          Deprecated. use EcksteinHechlerPropagator.osc2mean(Orbit) instead
protected  Orbit AbstractLyddanePropagator.computeSecular(Orbit orbit, AbstractLyddanePropagator.LyddaneParametersType fromType)
          Compute secular orbit in body frame from provided orbit.
protected  Orbit AbstractLyddanePropagator.convertFrame(Orbit orbit, Frame outputFrame)
          Convert provided orbit in output frame.
 Orbit EcksteinHechlerPropagator.mean2osc(Orbit orbit)
          Convert provided mean orbit into osculating elements.
 Orbit LyddaneLongPeriodPropagator.mean2osc(Orbit orbit)
          Convert provided mean orbit into osculating elements.
 Orbit LyddaneSecularPropagator.mean2osc(Orbit orbit)
          Convert provided mean orbit into osculating elements.
 Orbit EcksteinHechlerPropagator.osc2mean(Orbit orbit)
          Convert provided osculating orbit into mean elements.
 Orbit LyddaneLongPeriodPropagator.osc2mean(Orbit orbit)
          Convert provided osculating orbit into mean elements.
 Orbit LyddaneSecularPropagator.osc2mean(Orbit orbit)
          Convert provided osculating orbit into mean elements.
 Orbit EcksteinHechlerPropagator.propagateMeanOrbit(AbsoluteDate date)
          Propagate mean orbit until provided date.
 Orbit AbstractLyddanePropagator.propagateMeanOrbit(AbsoluteDate date)
          Propagate mean orbit until provided date.
 Orbit LyddaneSecularPropagator.propagateMeanOrbit(AbsoluteDate date)
          Propagate mean orbit until provided date.
protected  Orbit AdapterPropagator.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
 Orbit EcksteinHechlerPropagator.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
 Orbit AbstractLyddanePropagator.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
protected  Orbit KeplerianPropagator.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
 Orbit J2SecularPropagator.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
protected  Orbit AbstractLyddanePropagator.propagateOrbit(AbsoluteDate date, Orbit secularOrbit, Frame outputFrame, AbstractLyddanePropagator.LyddaneParametersType returnType)
          Propagate orbit to provided date.
 

Methods in org.orekit.propagation.analytical with parameters of type Orbit
 Orbit J2DifferentialEffect.apply(Orbit orbit1)
          Compute the effect of the maneuver on an orbit.
 Orbit EcksteinHechlerPropagator.computeMeanOrbit(Orbit osculating)
          Deprecated. use EcksteinHechlerPropagator.osc2mean(Orbit) instead
protected  Orbit AbstractLyddanePropagator.computeSecular(Orbit orbit, AbstractLyddanePropagator.LyddaneParametersType fromType)
          Compute secular orbit in body frame from provided orbit.
protected  Orbit AbstractLyddanePropagator.convertFrame(Orbit orbit, Frame outputFrame)
          Convert provided orbit in output frame.
 Orbit EcksteinHechlerPropagator.mean2osc(Orbit orbit)
          Convert provided mean orbit into osculating elements.
 Orbit LyddaneLongPeriodPropagator.mean2osc(Orbit orbit)
          Convert provided mean orbit into osculating elements.
 Orbit LyddaneSecularPropagator.mean2osc(Orbit orbit)
          Convert provided mean orbit into osculating elements.
 Orbit EcksteinHechlerPropagator.osc2mean(Orbit orbit)
          Convert provided osculating orbit into mean elements.
 Orbit LyddaneLongPeriodPropagator.osc2mean(Orbit orbit)
          Convert provided osculating orbit into mean elements.
 Orbit LyddaneSecularPropagator.osc2mean(Orbit orbit)
          Convert provided osculating orbit into mean elements.
protected  Orbit AbstractLyddanePropagator.propagateOrbit(AbsoluteDate date, Orbit secularOrbit, Frame outputFrame, AbstractLyddanePropagator.LyddaneParametersType returnType)
          Propagate orbit to provided date.
protected  void AbstractLyddanePropagator.updateSecularOrbit(Orbit secularOrbit)
          Update for secular Orbit.
 

Constructors in org.orekit.propagation.analytical with parameters of type Orbit
AbstractLyddanePropagator(Orbit secularOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents, MassProvider massProvider)
          Generic constructor.
EcksteinHechlerPropagator(Orbit initialOrbit, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents, double referenceRadius, double mu, Frame frame, double c20, double c30, double c40, double c50, double c60, MassProvider massProvider, ParametersType paramsType)
          Build a propagator from orbit, attitude provider, mass and potential.
EcksteinHechlerPropagator(Orbit initialOrbit, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents, double referenceRadius, double mu, Frame frame, double c20, double c30, double c40, double c50, double c60, ParametersType paramsType)
          Build a propagator from orbit, attitude provider for forces and events computation and potential.
EcksteinHechlerPropagator(Orbit initialOrbit, AttitudeProvider attitudeProv, double referenceRadius, double mu, Frame frame, double c20, double c30, double c40, double c50, double c60, MassProvider massProvider, ParametersType paramsType)
          Build a propagator from orbit, attitude provider, mass and potential.
EcksteinHechlerPropagator(Orbit initialOrbit, AttitudeProvider attitudeProv, double referenceRadius, double mu, Frame frame, double c20, double c30, double c40, double c50, double c60, ParametersType paramsType)
          Build a propagator from orbit, attitude provider and potential.
EcksteinHechlerPropagator(Orbit initialOrbit, double referenceRadius, double mu, Frame frame, double c20, double c30, double c40, double c50, double c60, MassProvider massProvider, ParametersType paramsType)
          Build a propagator from orbit, mass and potential.
EcksteinHechlerPropagator(Orbit initialOrbit, double referenceRadius, double mu, Frame frame, double c20, double c30, double c40, double c50, double c60, ParametersType paramsType)
          Build a propagator from orbit and potential.
J2DifferentialEffect(Orbit orbit0, Orbit orbit1, boolean applyBefore, double referenceRadius, double mu, double j2)
          Simple constructor.
J2DifferentialEffect(Orbit orbit0, Orbit orbit1, boolean applyBefore, PotentialCoefficientsProvider gravityField)
          Simple constructor.
J2SecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, Frame frameIn)
          Constructor without attitude provider and mass provider.
J2SecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, Frame frameIn, AttitudeProvider attitudeProvider)
          Constructor without mass provider.
J2SecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, Frame frameIn, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents)
          Constructor without mass provider.
J2SecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, Frame frameIn, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents, MassProvider massProvider)
          Generic constructor.
J2SecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, Frame frameIn, AttitudeProvider attitudeProvider, MassProvider massProvider)
          Generic constructor.
J2SecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, Frame frameIn, MassProvider massProvider)
          Constructor without attitude provider.
KeplerianPropagator(Orbit initialOrbit)
          Build a propagator from orbit only.
KeplerianPropagator(Orbit initialOrbit, AttitudeProvider attitudeProv)
          Build a propagator from orbit and a single attitude provider.
KeplerianPropagator(Orbit initialOrbit, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents)
          Build a propagator from orbit and attitude provider for forces and event computation.
KeplerianPropagator(Orbit initialOrbit, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents, double mu)
          Build a propagator from orbit, attitude provider for forces and events computation and central attraction coefficient μ.
KeplerianPropagator(Orbit initialOrbit, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents, double mu, MassProvider massProvider)
          Build propagator from orbit, attitude provider, central attraction coefficient μ and mass.
KeplerianPropagator(Orbit initialOrbit, AttitudeProvider attitudeProv, double mu)
          Build a propagator from orbit, a single attitude provider and central attraction coefficient μ.
KeplerianPropagator(Orbit initialOrbit, AttitudeProvider attitudeProv, double mu, MassProvider massProvider)
          Build propagator from orbit, attitude provider, central attraction coefficient μ and mass.
KeplerianPropagator(Orbit initialOrbit, double mu)
          Build a propagator from orbit and central attraction coefficient μ.
LyddaneLongPeriodPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn)
          Constructor without attitude provider and mass provider.
LyddaneLongPeriodPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, AttitudeProvider attitudeProvider)
          Constructor without mass provider.
LyddaneLongPeriodPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents)
          Constructor without mass provider.
LyddaneLongPeriodPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents, MassProvider massProvider)
          Generic constructor.
LyddaneLongPeriodPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, AttitudeProvider attitudeProvider, MassProvider massProvider)
          Generic constructor.
LyddaneLongPeriodPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, MassProvider massProvider)
          Constructor without attitude provider.
LyddaneSecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn)
          Constructor without attitude provider and mass provider.
LyddaneSecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, AttitudeProvider attitudeProvider)
          Constructor without mass provider.
LyddaneSecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents)
          Constructor without mass provider.
LyddaneSecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, AttitudeProvider attitudeProvForces, AttitudeProvider attitudeProvEvents, MassProvider massProvider)
          Generic constructor.
LyddaneSecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, AttitudeProvider attitudeProvider, MassProvider massProvider)
          Generic constructor.
LyddaneSecularPropagator(Orbit initialOrbit, double referenceRadiusIn, double muIn, double c20In, double c30In, double c40In, double c50In, Frame frameIn, ParametersType parametersTypeIn, MassProvider massProvider)
          Constructor without attitude provider.
 

Uses of Orbit in org.orekit.propagation.analytical.covariance
 

Methods in org.orekit.propagation.analytical.covariance that return Orbit
 Orbit CovarianceInterpolation.getOrbit()
           
 

Methods in org.orekit.propagation.analytical.covariance with parameters of type Orbit
 SymmetricMatrix OrbitCovariance.getCovarianceMatrix(Orbit refOrbit, OrbitType outCovType, Frame outFrame)
          Covariance matrix getter.
 OrbitCovariance OrbitCovariance.propagate(Orbit refOrbit, AbsoluteDate target)
          Propagate covariance.
 void CovarianceInterpolation.setOrbit(Orbit newOrbit)
          Allows to change the orbit.
 

Constructors in org.orekit.propagation.analytical.covariance with parameters of type Orbit
CovarianceInterpolation(AbsoluteDate t1In, double[][] matrix1, AbsoluteDate t2In, double[][] matrix2, int order, Orbit orbitSatellite, double muValue)
          Constructor of the class CovarianceInterpolation
CovarianceInterpolation(AbsoluteDate t1In, RealMatrix matrix1, AbsoluteDate t2In, RealMatrix matrix2, int order, Orbit orbitSatellite, double muValue)
          Constructor of the class CovarianceInterpolation
OrbitCovariance(Orbit orbit, OrbitType coordType, RealMatrix covMat)
          Simple constructor.
OrbitCovariance(Orbit orbit, RealMatrix covMat)
          Simple constructor.
 

Uses of Orbit in org.orekit.propagation.analytical.tle
 

Methods in org.orekit.propagation.analytical.tle that return Orbit
protected  Orbit TLEPropagator.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
 

Uses of Orbit in org.orekit.propagation.analytical.twod
 

Methods in org.orekit.propagation.analytical.twod that return Orbit
protected  Orbit Analytical2DPropagator.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
 

Uses of Orbit in org.orekit.propagation.events
 

Constructors in org.orekit.propagation.events with parameters of type Orbit
AlignmentDetector(Orbit orbit, PVCoordinatesProvider body, double alignAngle)
          Build a new alignment detector.
AlignmentDetector(Orbit orbit, PVCoordinatesProvider body, double alignAngle, double threshold)
          Build a new alignment detector.
AlignmentDetector(Orbit orbit, PVCoordinatesProvider body, double alignAngle, double threshold, EventDetector.Action actionStart, EventDetector.Action actionEnd)
          Build a new alignment detector.
AlignmentDetector(Orbit orbit, PVCoordinatesProvider body, double alignAngle, double threshold, EventDetector.Action actionStart, EventDetector.Action actionEnd, boolean removeStart, boolean removeEnd)
          Build a new alignment detector.
ApsideDetector(Orbit orbit, int slopeSelection)
          Build a new instance.
ApsideDetector(Orbit orbit, int slopeSelection, double threshold)
          Build a new instance.
NodeDetector(Orbit orbit, Frame frame, int slopeSelection)
          Build a new instance.
NodeDetector(Orbit orbit, Frame frame, int slopeSelection, double threshold)
          Build a new instance.
 

Uses of Orbit in org.orekit.propagation.numerical
 

Methods in org.orekit.propagation.numerical with parameters of type Orbit
 void TimeDerivativesEquations.initDerivatives(double[] yDot, Orbit currentOrbit)
          Initialize all derivatives to zero.
static double[][] NumericalPropagator.tolerances(double dP, Orbit orbit, OrbitType type)
          Estimate tolerance vectors for integrators.
 

Uses of Orbit in org.orekit.propagation.precomputed
 

Methods in org.orekit.propagation.precomputed that return Orbit
protected  Orbit IntegratedEphemeris.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
protected  Orbit Ephemeris.propagateOrbit(AbsoluteDate date)
          Extrapolate an orbit up to a specific target date.
protected  Orbit AbstractEphemeris.propagateOrbit(AbsoluteDate date)
           
 

Uses of Orbit in org.orekit.time
 

Methods in org.orekit.time with parameters of type Orbit
 double LocalTimeAngle.computeMeanLocalTimeAngle(Orbit orbit)
          Compute mean local time angle in TIRF frame in the range [-Π, Π[.
 double LocalTimeAngle.computeTrueLocalTimeAngle(Orbit orbit)
          Compute true local time angle in TIRF frame in the range [-Π, Π[.
 



Copyright © 2017 CNES. All Rights Reserved.