Uses of Class
org.orekit.frames.Frame

Packages that use Frame
fr.cnes.sirius.patrius.assembly   
fr.cnes.sirius.patrius.assembly.models   
fr.cnes.sirius.patrius.assembly.models.cook   
fr.cnes.sirius.patrius.assembly.properties   
fr.cnes.sirius.patrius.bodies   
fr.cnes.sirius.patrius.events   
fr.cnes.sirius.patrius.forces   
fr.cnes.sirius.patrius.forces.radiation   
fr.cnes.sirius.patrius.groundstation   
fr.cnes.sirius.patrius.guidance   
fr.cnes.sirius.patrius.projections   
fr.cnes.sirius.patrius.propagation   
fr.cnes.sirius.patrius.propagation.events.multi   
fr.cnes.sirius.patrius.propagation.numerical.multi   
fr.cnes.sirius.patrius.propagation.precomputed.multi   
fr.cnes.sirius.patrius.propagation.sampling.multi   
fr.cnes.sirius.patrius.signalpropagation   
fr.cnes.sirius.patrius.signalpropagation.iono   
fr.cnes.sirius.patrius.stela.bodies   
fr.cnes.sirius.patrius.stela.forces.atmospheres   
fr.cnes.sirius.patrius.stela.forces.noninertial   
fr.cnes.sirius.patrius.stela.orbits   
fr.cnes.sirius.patrius.stela.propagation   
fr.cnes.sirius.patrius.tools.force.validation   
fr.cnes.sirius.patrius.utils   
fr.cnes.sirius.patrius.wrenches   
fr.cnes.sirius.validate.mocks.ephemeris   
org.orekit.attitudes This package provides classes to represent simple attitudes. 
org.orekit.attitudes.directions   
org.orekit.bodies This package provides interface to represent the position and geometry of space objects such as stars, planets or asteroids. 
org.orekit.forces.atmospheres   
org.orekit.forces.drag   
org.orekit.forces.gravity   
org.orekit.forces.gravity.tides   
org.orekit.forces.gravity.variations   
org.orekit.forces.maneuvers This package provides models of simple maneuvers. 
org.orekit.forces.radiation   
org.orekit.forces.relativistic   
org.orekit.frames This package provides classes to handle frames and transforms between them. 
org.orekit.models.earth This package provides models that simulate certain physical phenomena experienced in the atmosphere of the earth. 
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.events This package provides interfaces and classes dealing with events occurring during propagation. 
org.orekit.propagation.numerical   
org.orekit.propagation.precomputed   
org.orekit.propagation.sampling This package provides interfaces and classes dealing with step handling during propagation. 
org.orekit.time This independent package provides classes to handle epochs, time scales, and to compare instants together. 
org.orekit.utils This package provides useful objects. 
org.orekit.wrenches   
 

Uses of Frame in fr.cnes.sirius.patrius.assembly
 

Methods in fr.cnes.sirius.patrius.assembly that return Frame
 Frame MainPart.getFrame()
           
 Frame IPart.getFrame()
           
 

Methods in fr.cnes.sirius.patrius.assembly with parameters of type Frame
 Assembly Vehicle.createAssembly(Frame frame)
          Create an Assembly.
 Assembly Vehicle.createAssembly(Frame frame, double cMass, double cDrag, double cSRP)
          Create an Assembly with multiplicative coefficients to take into account the change in surface for drag or SRP during a propagation of the change of dry mass.
 

Uses of Frame in fr.cnes.sirius.patrius.assembly.models
 

Methods in fr.cnes.sirius.patrius.assembly.models with parameters of type Frame
 Wrench AeroWrenchModel.dragWrench(SpacecraftState state, double density, Vector3D relativeVelocity, Vector3D origin, Frame frame)
          Compute the torque due to radiation pressire.
protected static Vector3D AeroModel.forceOnSphere(SpacecraftState state, IPart part, double density, Vector3D relativeVelocity, Frame mainPartFrame)
          Method to compute the force for the part model (cylinder, parallelepiped, sphere).
protected static Vector3D DirectRadiativeModel.forceOnSphere(SpacecraftState state, IPart part, Vector3D flux, Frame mainPartFrame)
          Method to compute the force for a spherical model.
 Matrix3D InertiaSimpleModel.getInertiaMatrix(Frame frame, AbsoluteDate date)
          Getter for the inertia matrix of the spacecraft, expressed with respect to the MASS CENTER in a given frame.
 Matrix3D InertiaComputedModel.getInertiaMatrix(Frame frame, AbsoluteDate date)
          Getter for the inertia matrix of the spacecraft, expressed with respect to the MASS CENTER in a given frame.
 Matrix3D IInertiaModel.getInertiaMatrix(Frame frame, AbsoluteDate date)
          Getter for the inertia matrix of the spacecraft, expressed with respect to the MASS CENTER in a given frame.
 Matrix3D InertiaSimpleModel.getInertiaMatrix(Frame frame, AbsoluteDate date, Vector3D inertiaReferencePoint)
          Getter for the inertia matrix of the spacecraft, once expressed with respect to a point that can be different from the mass center.
 Matrix3D InertiaComputedModel.getInertiaMatrix(Frame frame, AbsoluteDate date, Vector3D inertiaReferencePoint)
          Getter for the inertia matrix of the spacecraft, once expressed with respect to a point that can be different from the mass center.
 Matrix3D IInertiaModel.getInertiaMatrix(Frame frame, AbsoluteDate date, Vector3D inertiaReferencePoint)
          Getter for the inertia matrix of the spacecraft, once expressed with respect to a point that can be different from the mass center.
 Vector3D InertiaSimpleModel.getMassCenter(Frame frame, AbsoluteDate date)
          Getter for the mass center.
 Vector3D InertiaComputedModel.getMassCenter(Frame frame, AbsoluteDate date)
          Getter for the mass center.
 Vector3D IInertiaModel.getMassCenter(Frame frame, AbsoluteDate date)
          Getter for the mass center.
 PVCoordinates SensorModel.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the sensor part in the selected frame.
 Vector3D[] SensorModel.getRefrenceAxis(Frame frame, AbsoluteDate date)
          Computes the reference axis of the sensor in a given frame at a date
 Vector3D SensorModel.getSightAxis(Frame frame, AbsoluteDate date)
          Computes the sight axis of the sensor in a given frame at a date
 Wrench DirectRadiativeWrenchModel.radiationWrench(SpacecraftState state, Vector3D flux, Vector3D origin, Frame frame)
          Compute the torque due to radiation pressire.
 

Constructors in fr.cnes.sirius.patrius.assembly.models with parameters of type Frame
InertiaSimpleModel(double mass, Vector3D massCenter, Matrix3D inertiaMatrix, Frame frame, String partName)
          Constructor for a simple inertia model.
InertiaSimpleModel(double mass, Vector3D massCenter, Matrix3D inertiaMatrix, Vector3D inertiaReferencePoint, Frame frame, String partName)
          Constructor for a simple inertia model; the inertia matrix is expressed with respect to a point that can be different from the mass center.
 

Uses of Frame in fr.cnes.sirius.patrius.assembly.models.cook
 

Constructors in fr.cnes.sirius.patrius.assembly.models.cook with parameters of type Frame
CnCookModel(ExtendedAtmosphere atmos, Facet afacet, Frame afacetFrame, double eps, double wallGasTemp)
          Constructor with constant wall gas temperature.
CnCookModel(ExtendedAtmosphere atmos, Facet afacet, Frame afacetFrame, double eps, WallGasTemperatureProvider wallGasTemp)
          Constructor.
CtCookModel(ExtendedAtmosphere atmos, Facet afacet, Frame afacetFrame, double eps)
          Constructor.
 

Uses of Frame in fr.cnes.sirius.patrius.assembly.properties
 

Methods in fr.cnes.sirius.patrius.assembly.properties with parameters of type Frame
 double AeroSphereProperty.getCrossSection(SpacecraftState state, Vector3D relativeVelocity, Frame mainPartFrame, Frame partFrame)
           
 double RadiativeSphereProperty.getCrossSection(SpacecraftState state, Vector3D flux, Frame mainPartFrame, Frame partFrame)
           
 double RadiativeCrossSectionProperty.getCrossSection(SpacecraftState state, Vector3D flux, Frame mainPartFrame, Frame partFrame)
          Compute the cross section of main shape using the relative velocity in the part (having the aero property) frame as the direction to provider to the CrossSectionProvider.getCrossSection(Vector3D).
 double AeroCrossSectionProperty.getCrossSection(SpacecraftState state, Vector3D relativeVelocity, Frame mainPartFrame, Frame partFrame)
          Compute the cross section of main shape using the relative velocity in the part (having the aero property) frame as the direction to provider to the CrossSectionProvider.getCrossSection(Vector3D).
 

Uses of Frame in fr.cnes.sirius.patrius.bodies
 

Methods in fr.cnes.sirius.patrius.bodies with parameters of type Frame
 Line BasicBoardSun.getLine(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
           Get the line from the position in pvCoord to the Sun.
 Vector3D BasicBoardSun.getVector(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
           Get the direction of the sun.
 

Uses of Frame in fr.cnes.sirius.patrius.events
 

Methods in fr.cnes.sirius.patrius.events that return Frame
 Frame EarthZoneDetector.getFrame()
          Get the frame.
 

Constructors in fr.cnes.sirius.patrius.events with parameters of type Frame
EarthZoneDetector(List<Vector3D[]> directionsList, Frame bodyFrame)
          Constructor for the earth zones entering detector with default maxCheck and convergence threshold.
EarthZoneDetector(List<Vector3D[]> directionsList, Frame bodyFrame, double maxCheck, double threshold)
          Constructor for the earth zones entering detector.
EarthZoneDetector(List<Vector3D[]> directionsList, Frame bodyFrame, double maxCheck, double threshold, EventDetector.Action entry, EventDetector.Action exit)
          Constructor for the earth zones entering detector.
EarthZoneDetector(List<Vector3D[]> directionsList, Frame bodyFrame, double maxCheck, double threshold, EventDetector.Action entry, EventDetector.Action exit, boolean removeEntry, boolean removeExit)
          Constructor.
 

Uses of Frame in fr.cnes.sirius.patrius.forces
 

Methods in fr.cnes.sirius.patrius.forces that return Frame
 Frame ConstantThrustManeuver.getFrame()
          Get the frame of the acceleration inDirection.
 Frame VariableThrustManeuver.getFrame()
          Get the frame of the acceleration direction.
 Frame EmpiricalForce.getLocalFrame()
           
 

Methods in fr.cnes.sirius.patrius.forces with parameters of type Frame
 Vector3D EmpiricalForce.computeAcceleration(PVCoordinates pv, LocalOrbitalFrame localFrameValidation, Vector3D vectorS, Frame frame, SpacecraftState state)
           Method to compute the acceleration.
 

Constructors in fr.cnes.sirius.patrius.forces with parameters of type Frame
ConstantThrustManeuver(AbsoluteDate date, double duration, double thrust, double isp, Vector3D inDirection, MassProvider massProvider, String partNameIn, Frame frameIn)
          Constructor for a constant direction in provided frame and constant thrust.
ConstantThrustManeuver(AbsoluteDate date, double duration, Parameter thrust, Parameter flowRate, Vector3D inDirection, MassProvider massProvider, String partNameIn, Frame frameIn)
          Constructor for a constant dDirection in provided frame and constant thrust using Parameter.
ConstantThrustManeuver(AbsoluteDate date, double duration, PropulsiveProperty engine, Parameter flowRate, Vector3D inDirection, MassProvider massProvider, TankProperty tank, Frame frameIn)
          Constructor for a constant direction in satellite frame and constant thrust using Parameter, PropulsiveProperty and TankProperty.
ConstantThrustManeuver(AbsoluteDate date, double duration, PropulsiveProperty engine, Vector3D inDirection, MassProvider massProvider, TankProperty tank, Frame frameIn)
          Constructor for a constant direction in provided frame and constant thrust, using PropulsiveProperty and TankProperty.
ConstantThrustManeuver(EventDetector startEventDetector, EventDetector stopEventDetector, double thrust, double isp, Vector3D inDirection, MassProvider massProvider, String partNameIn, Frame frameIn)
          Constructor for a constant direction in provided frame and constant thrust.
ConstantThrustManeuver(EventDetector startEventDetector, EventDetector stopEventDetector, PropulsiveProperty engine, Vector3D inDirection, MassProvider massProvider, TankProperty tank, Frame frameIn)
          Constructor for a constant direction in provided frame and constant thrust with PropulsiveProperty and TankProperty properties.
EmpiricalForce(int harmonicFactor, Vector3D vectorS, IParamDiffFunction ax, IParamDiffFunction ay, IParamDiffFunction az, IParamDiffFunction bx, IParamDiffFunction by, IParamDiffFunction bz, IParamDiffFunction cx, IParamDiffFunction cy, IParamDiffFunction cz, Frame coeffsFrame)
          Simple constructor for an empiric force using parameterizable functions for A; B and C coef with a given frame.
EmpiricalForce(int harmonicFactor, Vector3D vectorS, Parameter ax, Parameter ay, Parameter az, Parameter bx, Parameter by, Parameter bz, Parameter cx, Parameter cy, Parameter cz, Frame coeffsFrame)
          Simple constructor for an empiric force using Parameter for A; B and C coef with a given frame.
EmpiricalForce(int harmonicFactor, Vector3D vectorS, Vector3D a, Vector3D b, Vector3D c, Frame coeffsFrame)
          Simple constructor for an empiric force, assigning a generic frame to the A, B, C coefficients frame.
VariableThrustManeuver(AbsoluteDate date, double duration, IDependentVariable<SpacecraftState> variableThrust, IDependentVariable<SpacecraftState> variableIsp, IDependentVectorVariable<SpacecraftState> variableDirection, MassProvider massModel, String partName, Frame refFrame)
          Constructor for a variable direction in provided frame, thrust and ISP.
VariableThrustManeuver(AbsoluteDate date, double duration, PropulsiveProperty engine, IDependentVectorVariable<SpacecraftState> variableDirection, MassProvider massModel, TankProperty tank, Frame refFrame)
          Constructor for a variable direction in provided frame, thrust and ISP, using PropulsiveProperty and TankProperty.
VariableThrustManeuver(EventDetector startEventDetector, EventDetector stopEventDetector, IDependentVariable<SpacecraftState> variableThrust, IDependentVariable<SpacecraftState> variableIsp, IDependentVectorVariable<SpacecraftState> variableDirection, MassProvider massModel, String partName, Frame refFrame)
          Constructor for a variable direction in provided frame, thrust and ISP.
VariableThrustManeuver(EventDetector startEventDetector, EventDetector stopEventDetector, PropulsiveProperty engine, IDependentVectorVariable<SpacecraftState> variableDirection, MassProvider massModel, TankProperty tank, Frame refFrame)
          Constructor for a variable direction in spacecraft frame, thrust and ISP, using PropulsiveProperty and TankProperty.
 

Uses of Frame in fr.cnes.sirius.patrius.forces.radiation
 

Methods in fr.cnes.sirius.patrius.forces.radiation with parameters of type Frame
static double PatriusSolarRadiationPressure.getLightningRatio(PVCoordinatesProvider sun, Vector3D satSunVector, GeometricBodyShape earthModel, Vector3D position, Frame frame, AbsoluteDate date)
          Get the lightning ratio ([0-1]).
 

Uses of Frame in fr.cnes.sirius.patrius.groundstation
 

Methods in fr.cnes.sirius.patrius.groundstation that return Frame
 Frame RFStationAntenna.getFrame()
          Returns ground station topocentric frame.
 

Methods in fr.cnes.sirius.patrius.groundstation with parameters of type Frame
 PVCoordinates RFStationAntenna.getPVCoordinates(AbsoluteDate date, Frame frame)
           
 PVCoordinates GeometricStationAntenna.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the station antenna in the selected frame.
 

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

Methods in fr.cnes.sirius.patrius.guidance with parameters of type Frame
static AngularVelocitiesHarmonicProfile GuidanceProfileBuilder.computeAngularVelocitiesHarmonicProfile(AttitudeLawLeg attitude, PVCoordinatesProvider provider, Frame frame, AbsoluteDate tref, double period, int order, KinematicsToolkit.IntegrationType integType, double integStep)
          Compute the angular velocities harmonic guidance profile.
 Attitude QuaternionHarmonicProfile.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude QuaternionPolynomialProfile.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude AngularVelocitiesPolynomialProfile.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate userDate, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude AngularVelocitiesHarmonicProfile.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate userDate, Frame frame)
          Compute the attitude corresponding to an orbital state.
 

Constructors in fr.cnes.sirius.patrius.guidance with parameters of type Frame
AngularVelocitiesHarmonicProfile(AbsoluteDate origin, Rotation initialRotation, Frame frame, FourierSeries xAngle, FourierSeries yAngle, FourierSeries zAngle, AbsoluteDateInterval timeInterval, KinematicsToolkit.IntegrationType integType, double integStep)
          Create a harmonic, angular velocities guidance profile.
AngularVelocitiesPolynomialProfile(Frame frame, AbsoluteDateInterval timeInterval, Rotation initialRotation, List<Vector3DPolynomialSegment> polynomials, KinematicsToolkit.IntegrationType integType, double integStep)
          Create a polynomial, angular velocity guidance profile.
QuaternionHarmonicProfile(AbsoluteDate origin, Frame frame, FourierSeries q0, FourierSeries q1, FourierSeries q2, FourierSeries q3, AbsoluteDateInterval timeInterval)
          Create a harmonic, quaternion guidance profile.
QuaternionPolynomialProfile(Frame frame, AbsoluteDateInterval timeInterval, List<QuaternionPolynomialSegment> polynomials)
          Create a polynomial, quaternion guidance profile.
 

Uses of Frame in fr.cnes.sirius.patrius.projections
 

Constructors in fr.cnes.sirius.patrius.projections with parameters of type Frame
ProjectionEllipsoid(double ae, double f, Frame bodyFrame, String name)
          Constructor for the body ellipsoid.
 

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

Methods in fr.cnes.sirius.patrius.propagation that return Frame
 Frame MultiPropagator.getFrame(String satId)
          Get the frame in which the orbit is propagated.
 

Constructors in fr.cnes.sirius.patrius.propagation with parameters of type Frame
PVCoordinatePropagator(PVCoordinatesProvider pvCoordProvider, AbsoluteDate initDate, double mu, Frame frame)
          Creates an instance of PVCoordinatePropagator without attitude and additional state providers
PVCoordinatePropagator(PVCoordinatesProvider pvCoordProvider, AbsoluteDate initDate, double mu, Frame frame, AttitudeProvider attProviderForces, AttitudeProvider attProviderEvents, List<AdditionalStateProvider> additionalStateProviders)
          Creates an instance of PVCoordinatePropagator with PV, attitude for forces, attitude for events, and additional state providers given by the user.
 

Uses of Frame in fr.cnes.sirius.patrius.propagation.events.multi
 

Constructors in fr.cnes.sirius.patrius.propagation.events.multi with parameters of type Frame
AdaptedMonoEventDetector(EventDetector detector, OrbitType orbitType, PositionAngle angleType, AttitudeProvider attProviderForces, AttitudeProvider attProviderEvents, AbsoluteDate referenceDate, double mu, Frame integrationFrame, MultiStateVectorInfo stateVectorInfo, String satId)
          Build a wrapped event detector.
 

Constructor parameters in fr.cnes.sirius.patrius.propagation.events.multi with type arguments of type Frame
AdaptedMultiEventDetector(MultiEventDetector detector, OrbitType orbitType, PositionAngle angleType, Map<String,AttitudeProvider> attProvidersForces, Map<String,AttitudeProvider> attProvidersEvents, AbsoluteDate referenceDate, Map<String,Double> muMap, Map<String,Frame> framesMap, MultiStateVectorInfo stateVectorInfo)
          Build a wrapped multi-sat event detector.
 

Uses of Frame in fr.cnes.sirius.patrius.propagation.numerical.multi
 

Methods in fr.cnes.sirius.patrius.propagation.numerical.multi that return Frame
 Frame MultiNumericalPropagator.getFrame(String satId)
           
 

Methods in fr.cnes.sirius.patrius.propagation.numerical.multi with parameters of type Frame
 PVCoordinates MultiNumericalPropagator.getPVCoordinates(AbsoluteDate date, Frame frame, String satId)
          Get the PVCoordinates of the body in the selected frame.
 SpacecraftState MultiStateVectorInfo.mapArrayToState(double[] y, AbsoluteDate currentDate, OrbitType orbitType, PositionAngle angleType, AttitudeProvider attProviderForces, AttitudeProvider attProviderEvents, double mu, Frame integrationFrame, String satId)
          Extract a given SpacecraftState from the state vector.
 void MultiNumericalPropagator.setOrbitFrame(String satId, Frame frame)
          Set a frame for propagation The initial state must have first been added using the MultiNumericalPropagator.addInitialState(SpacecraftState, String) method before defining the associated integration frame.
 

Method parameters in fr.cnes.sirius.patrius.propagation.numerical.multi with type arguments of type Frame
 void MultiEphemerisModeHandler.initialize(OrbitType orbit, PositionAngle angle, Map<String,AttitudeProvider> attitudeProvidersForces, Map<String,AttitudeProvider> attitudeProvidersEvents, MultiStateVectorInfo stateVectorInfo, boolean activateHandlers, AbsoluteDate reference, Map<String,Frame> frame, Map<String,Double> mu)
          Initialize the mode handler.
 void MultiModeHandler.initialize(OrbitType orbit, PositionAngle angle, Map<String,AttitudeProvider> attitudeProvidersForces, Map<String,AttitudeProvider> attitudeProvidersEvents, MultiStateVectorInfo stateVectorInfo, boolean activateHandlers, AbsoluteDate reference, Map<String,Frame> frame, Map<String,Double> mu)
          Initialize the mode handler.
 Map<String,SpacecraftState> MultiStateVectorInfo.mapArrayToStates(double[] y, AbsoluteDate currentDate, OrbitType orbitType, PositionAngle angleType, Map<String,AttitudeProvider> attProvidersForces, Map<String,AttitudeProvider> attProvidersEvents, Map<String,Double> mu, Map<String,Frame> integrationFrame)
          Convert state vector into a Map of SpacecraftState
 

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

Methods in fr.cnes.sirius.patrius.propagation.precomputed.multi with parameters of type Frame
 PVCoordinates MultiIntegratedEphemeris.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 

Constructors in fr.cnes.sirius.patrius.propagation.precomputed.multi with parameters of type Frame
MultiIntegratedEphemeris(List<AbsoluteDate> startDatesIn, List<AbsoluteDate> minDatesIn, List<AbsoluteDate> maxDatesIn, OrbitType orbitTypeIn, PositionAngle angleTypeIn, AttitudeProvider attitudeProviderForces, AttitudeProvider attitudeProviderEvents, MultiStateVectorInfo stateInfos, List<ContinuousOutputModel> modelsIn, Frame referenceFrameIn, double muIn, String satIdIn)
          Creates a new instance of IntegratedEphemeris.
 

Uses of Frame in fr.cnes.sirius.patrius.propagation.sampling.multi
 

Method parameters in fr.cnes.sirius.patrius.propagation.sampling.multi with type arguments of type Frame
 void MultiAdaptedStepHandler.initialize(OrbitType orbit, PositionAngle angle, Map<String,AttitudeProvider> attProvidersForces, Map<String,AttitudeProvider> attProvidersEvents, MultiStateVectorInfo stateVectorInfo, boolean activateHandlers, AbsoluteDate reference, Map<String,Frame> frameMap, Map<String,Double> muMap)
          Initialize the mode handler.
 

Uses of Frame in fr.cnes.sirius.patrius.signalpropagation
 

Methods in fr.cnes.sirius.patrius.signalpropagation with parameters of type Frame
 Vector3D SignalPropagation.getVector(Frame expressionFrame)
           
 

Constructors in fr.cnes.sirius.patrius.signalpropagation with parameters of type Frame
SignalPropagation(Vector3D propagationVector, AbsoluteDate inEmissionDate, AbsoluteDate inReceptionDate, Frame refFrame, SignalPropagationModel.FixedDate fixedDate)
          Constructor with computation of one of the dates
SignalPropagationModel(Frame frame, double threshold)
          Constructor of the signal propagation model.
 

Uses of Frame in fr.cnes.sirius.patrius.signalpropagation.iono
 

Methods in fr.cnes.sirius.patrius.signalpropagation.iono with parameters of type Frame
 double BentModel.computeElectronicCont(AbsoluteDate date, Vector3D satellite, Frame frameSat)
          Computation of the electric content between the station and the satellite at a date.
 double BentModel.computeSignalDelay(AbsoluteDate date, Vector3D satellite, Frame frameSat)
           
 double IonosphericCorrection.computeSignalDelay(AbsoluteDate date, Vector3D satellite, Frame satFrame)
          Calculates the ionospheric signal delay for the signal path from the position of the transmitter and the receiver and the current date.
 

Constructors in fr.cnes.sirius.patrius.signalpropagation.iono with parameters of type Frame
BentModel(R12Provider r12Provider, SolarActivityDataProvider solarActivity, USKProvider uskProvider, BodyShape earth, Vector3D inStation, Frame inFrameSta, double freq)
          Constructor for the Bent ionospheric correction model.
 

Uses of Frame in fr.cnes.sirius.patrius.stela.bodies
 

Methods in fr.cnes.sirius.patrius.stela.bodies with parameters of type Frame
 PVCoordinates MeeusSunStela.getPVCoordinates(AbsoluteDate date, Frame frame)
          Deprecated.  
 PVCoordinates MeeusMoonStela.getPVCoordinates(AbsoluteDate date, Frame frame)
           
static void MeeusSunStela.updateTransform(AbsoluteDate date, Frame frame)
          Deprecated. Update cached transform from FramesFactory.getMOD(boolean) to provided frame.
static void MeeusMoonStela.updateTransform(AbsoluteDate date, Frame frame)
          Update cached transform from FramesFactory.getMOD(boolean) to provided frame.
 

Uses of Frame in fr.cnes.sirius.patrius.stela.forces.atmospheres
 

Methods in fr.cnes.sirius.patrius.stela.forces.atmospheres with parameters of type Frame
 AtmosphereData MSIS00Adapter.getData(AbsoluteDate date, Vector3D position, Frame frame)
          Get detailed atmospheric data.
 double MSIS00Adapter.getDensity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local density.
 double MSIS00Adapter.getSpeedOfSound(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local speed of sound.
 Vector3D MSIS00Adapter.getVelocity(AbsoluteDate date, Vector3D position, Frame frame)
           
 

Uses of Frame in fr.cnes.sirius.patrius.stela.forces.noninertial
 

Methods in fr.cnes.sirius.patrius.stela.forces.noninertial with parameters of type Frame
 Vector3D NonInertialContribution.computeOmega(AbsoluteDate date, Frame frame1, Frame frame2)
          Compute rotation vector of frame2 with respect to frame1 expressed in frame2, which is the rotation vector from frame1 to frame2.
 Vector3D NonInertialContribution.computeOmegaDerivative(AbsoluteDate date, Frame frame1, Frame frame2, double dt)
          Compute rotation vector derivative from frame1 to frame2 using finite differences.
 

Constructors in fr.cnes.sirius.patrius.stela.forces.noninertial with parameters of type Frame
NonInertialContribution(int quadPointsIn, Frame referenceSystemIn)
          Constructor.
 

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

Methods in fr.cnes.sirius.patrius.stela.orbits with parameters of type Frame
 PVCoordinates StelaEquinoctialOrbit.getPVCoordinates(AbsoluteDate otherDate, Frame otherFrame)
           
 

Constructors in fr.cnes.sirius.patrius.stela.orbits with parameters of type Frame
StelaEquinoctialOrbit(double aIn, double exIn, double eyIn, double ixIn, double iyIn, double lMIn, Frame frame, AbsoluteDate date, double mu)
          Creates a new instance.
StelaEquinoctialOrbit(double aIn, double exIn, double eyIn, double ixIn, double iyIn, double lMIn, Frame frame, AbsoluteDate date, double mu, boolean isCorrectedIn)
          Creates a new instance.
StelaEquinoctialOrbit(IOrbitalParameters params, Frame frame, AbsoluteDate date)
          Creates a new instance.
StelaEquinoctialOrbit(PVCoordinates pvCoordinates, Frame frame, AbsoluteDate date, double mu)
          Constructor from cartesian parameters.
 

Uses of Frame in fr.cnes.sirius.patrius.stela.propagation
 

Methods in fr.cnes.sirius.patrius.stela.propagation that return Frame
 Frame StelaAbstractPropagator.getFrame()
          Get the frame in which the orbit is propagated.
 

Methods in fr.cnes.sirius.patrius.stela.propagation with parameters of type Frame
 PVCoordinates StelaAbstractPropagator.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 void StelaAbstractPropagator.setOrbitFrame(Frame frame)
          Set propagation frame.
 

Uses of Frame in fr.cnes.sirius.patrius.tools.force.validation
 

Methods in fr.cnes.sirius.patrius.tools.force.validation with parameters of type Frame
 PVCoordinates BasicPVCoordinatesProvider.getPVCoordinates(AbsoluteDate date, Frame inFrame)
          Get the PVCoordinates of the body in the selected frame.
 

Constructors in fr.cnes.sirius.patrius.tools.force.validation with parameters of type Frame
BasicPVCoordinatesProvider(PVCoordinates inCoordinates, Frame inFrame)
          Build a direction from an origin and a target described by their PVCoordinatesProvider
 

Uses of Frame in fr.cnes.sirius.patrius.utils
 

Methods in fr.cnes.sirius.patrius.utils with parameters of type Frame
 PVCoordinates AlmanacPVCoordinates.getPVCoordinates(AbsoluteDate date, Frame frame)
          Geometric computation of the position to a date.
 

Uses of Frame in fr.cnes.sirius.patrius.wrenches
 

Methods in fr.cnes.sirius.patrius.wrenches with parameters of type Frame
 Vector3D SolarRadiationWrench.computeTorque(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Vector3D GravitationalAttractionWrench.computeTorque(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Vector3D DragWrench.computeTorque(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Vector3D GenericWrenchModel.computeTorque(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Vector3D MagneticWrench.computeTorque(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Wrench SolarRadiationWrench.computeWrench(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Wrench GravitationalAttractionWrench.computeWrench(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Wrench DragWrench.computeWrench(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Wrench GenericWrenchModel.computeWrench(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Wrench MagneticWrench.computeWrench(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Wrench DragWrenchSensitive.dragWrench(SpacecraftState state, double density, Vector3D relativeVelocity, Vector3D origin, Frame frame)
          Compute the torque due to radiation pressire.
 Wrench RadiationWrenchSensitive.radiationWrench(SpacecraftState state, Vector3D flux, Vector3D origin, Frame frame)
          Compute the torque due to radiation pressire.
 

Uses of Frame in fr.cnes.sirius.validate.mocks.ephemeris
 

Methods in fr.cnes.sirius.validate.mocks.ephemeris that return Frame
 Frame UserEphemeris.getReferenceFrame()
           
 Frame IUserEphemeris.getReferenceFrame()
           
 

Methods in fr.cnes.sirius.validate.mocks.ephemeris with parameters of type Frame
 PVCoordinates UserCelestialBody.getPVCoordinates(AbsoluteDate date, Frame frame)
          Computes the PV coordinates at a date using linear interpolator.
 PVCoordinates UserCelestialBody.getPVCoordinatesLagrange4(AbsoluteDate date, Frame frame)
          Computes the PV coordinates at a date using Lagrange 4 interpolator.
 

Constructors in fr.cnes.sirius.validate.mocks.ephemeris with parameters of type Frame
UserEphemeris(String ephemerisFile, DateComponents referenceEpoch, TimeScale timeScale, Frame frame)
          Constructor.
 

Uses of Frame in org.orekit.attitudes
 

Subclasses of Frame in org.orekit.attitudes
 class AttitudeFrame
          This class is a special implementation of the Frame class; it represents a dynamic spacecraft frame, i.e.
 class OrientationFrame
          This class is a special implementation of the Frame class; it represents a dynamic orientation frame, i.e.
 

Fields in org.orekit.attitudes declared as Frame
protected  Frame AbstractIsisSpinBiasSlew.refFrame
          Reference frame.
 

Methods in org.orekit.attitudes that return Frame
 Frame GroundPointing.getBodyFrame()
          Get the body frame.
 Frame Attitude.getReferenceFrame()
          Get the reference frame.
 

Methods in org.orekit.attitudes with parameters of type Frame
 SortedSet<Attitude> AbstractAttitudeEphemerisGenerator.generateEphemeris(AbsoluteDateInterval ephemerisInterval, Frame frame)
          Computes attitude ephemeris using a fixed or variable time step and choosing the interval of validity.
 SortedSet<Attitude> AbstractAttitudeEphemerisGenerator.generateEphemeris(Frame frame)
          Computes attitude ephemeris using a fixed or variable time step.
 Attitude Slew.getAttitude(AbsoluteDate date, Frame frame)
          Compute the attitude.
 Attitude ConstantSpinSlew.getAttitude(AbsoluteDate date, Frame frame)
           
 Attitude AbstractIsisSpinBiasSlew.getAttitude(AbsoluteDate date, Frame frame)
          Compute the attitude.
 Attitude TwoSpinBiasSlew.getAttitude(AbsoluteDate date, Frame frame)
           
 Attitude ComposedAttitudeLaw.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
           
 Attitude BodyCenterPointing.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude TargetPointing.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude ConstantAttitudeLaw.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudeLawLeg.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
           
 Attitude YawCompensation.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude YawSteering.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude LofOffset.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude RelativeTabulatedAttitudeLaw.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude IsisSunPointing.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude TwoDirectionsAttitude.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudeLegLaw.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudeProvider.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude TabulatedAttitude.getAttitude(PVCoordinatesProvider pvProvider, AbsoluteDate date, Frame inFrame)
          Compute the attitude corresponding to an orbital state.
 Attitude CelestialBodyPointed.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude AbstractSlew.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
           
 Attitude AeroAttitudeLaw.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudeLegsSequence.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Gets the attitude from the sequence.
The AttitudeLeg matching the date is called to compute the attitude.
 Attitude RelativeTabulatedAttitudeLeg.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude LofOffsetPointing.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude SpinStabilized.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude FixedRate.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude GroundPointing.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude AttitudesSequence.getAttitude(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the attitude corresponding to an orbital state.
 Attitude GroundPointingWrapper.getBaseState(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the base system state at given date, without compensation.
abstract  TimeStampedAngularCoordinates GroundPointingWrapper.getCompensation(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame, Attitude base)
          Compute the TimeStampedAngularCoordinates at a given time.
 TimeStampedAngularCoordinates YawCompensation.getCompensation(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame orbitFrame, Attitude base)
          Compute the TimeStampedAngularCoordinates at a given time.
 TimeStampedAngularCoordinates YawSteering.getCompensation(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame orbitFrame, Attitude base)
          Compute the TimeStampedAngularCoordinates at a given time.
 Attitude AttitudeLegsSequence.getOldAttitudeOnTransition(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Returns the attitude at a transition date for the old attitude law (the law previous to the valid transition law).
 Rotation DirectionTrackingOrientation.getOrientation(AbsoluteDate date, Frame frame)
           
 Rotation IOrientationLaw.getOrientation(AbsoluteDate date, Frame frame)
          Gets the rotation defining the orientation with respect to a given frame at a given date.
 Vector3D TwoSpinBiasSlew.getSpinDerivatives(AbsoluteDate date, Frame frame)
          get the spin derivatives (default implementation : finite differences differentiator).
 Vector3DFunction TwoSpinBiasSlew.getSpinFunction(Frame frame, AbsoluteDate zeroAbscissa)
           
protected  Vector3D GroundPointingWrapper.getTargetPoint(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the target point in specified frame.
protected  Vector3D TargetGroundPointing.getTargetPoint(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the target point in specified frame.
protected  Vector3D BodyCenterGroundPointing.getTargetPoint(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
           
protected  Vector3D LofOffsetPointing.getTargetPoint(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the target point in specified frame.
protected  Vector3D NadirPointing.getTargetPoint(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the target point in specified frame.
protected abstract  Vector3D GroundPointing.getTargetPoint(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the target point in specified frame.
protected  TimeStampedPVCoordinates GroundPointingWrapper.getTargetPV(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the target point position/velocity in specified frame.
 TimeStampedPVCoordinates NadirPointing.getTargetPV(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
           
protected  TimeStampedPVCoordinates GroundPointing.getTargetPV(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the target point position/velocity in specified frame.
 double YawCompensation.getYawAngle(PVCoordinatesProvider pvProv, AbsoluteDate date, Frame frame)
          Compute the yaw compensation angle at date.
static Attitude Attitude.slerp(AbsoluteDate date, Attitude attitude1, Attitude attitude2, Frame frame, boolean computeSpinDerivative)
          The slerp interpolation method is efficient but is less accurate than the interpolate method.
 Attitude Attitude.withReferenceFrame(Frame newReferenceFrame)
          Get a similar attitude with a specific reference frame.
 Attitude Attitude.withReferenceFrame(Frame newReferenceFrame, boolean spinDerivativesComputation)
          Get a similar attitude with a specific reference frame.
 

Constructors in org.orekit.attitudes with parameters of type Frame
Attitude(AbsoluteDate date, Frame referenceFrame, AngularCoordinates orientation)
          Creates a new instance.
Attitude(AbsoluteDate date, Frame referenceFrame, Rotation attitude, Vector3D spin)
          Creates a new instance.
Attitude(AbsoluteDate date, Frame referenceFrame, Rotation attitude, Vector3D spin, Vector3D acceleration)
          Creates a new instance.
Attitude(double[] y, AbsoluteDate date, Frame referenceFrame)
          Creates a new instance from an array containing a quaternion and a spin vector.
Attitude(Frame referenceFrame, TimeStampedAngularCoordinates orientation)
          Creates a new instance.
AttitudeFrame(PVCoordinatesProvider pvProvider, AttitudeLaw attitudeLaw, Frame referenceFrame)
          Constructor of the dynamic spacecraft frame.
AttitudeTransformProvider(AttitudeLaw law, PVCoordinatesProvider pv, Frame frame)
          Protected constructor.
BodyCenterPointing(Frame bodyFrame)
          Creates new instance.
CelestialBodyPointed(Frame pCelestialFrame, PVCoordinatesProvider pPointedBody, Vector3D pPhasingCel, Vector3D pPointingSat, Vector3D pPhasingSat)
          Creates new instance.
ConstantAttitudeLaw(Frame referenceFrame, Rotation rotation)
          Creates new instance.
LofOffset(Frame inertialFrame, LOFType type)
          Create a LOF-aligned attitude.
LofOffset(Frame pInertialFrame, LOFType type, RotationOrder order, double alpha1, double alpha2, double alpha3)
          Creates new instance.
OrientationTransformProvider(IOrientationLaw law, Frame frame)
          Protected constructor.
RelativeTabulatedAttitudeLaw(AbsoluteDate refDate, List<Pair<Double,AngularCoordinates>> angularCoordinates, Frame frame, RelativeTabulatedAttitudeLaw.AroundAttitudeType lawBefore, RelativeTabulatedAttitudeLaw.AroundAttitudeType lawAfter)
          Create a RelativeTabulatedAttitudeLaw object with list of Angular Coordinates (during the interval of validity), a law before the interval and a law after the interval.
RelativeTabulatedAttitudeLaw(Frame frame, AbsoluteDate refDate, List<Pair<Double,Rotation>> orientations, RelativeTabulatedAttitudeLaw.AroundAttitudeType lawBefore, RelativeTabulatedAttitudeLaw.AroundAttitudeType lawAfter)
          Create a RelativeTabulatedAttitudeLaw object with list of rotations (during the interval of validity), a law before the interval and a law after the interval.
RelativeTabulatedAttitudeLeg(AbsoluteDate referenceDate, Frame frame, List<Pair<Double,AngularCoordinates>> angularCoordinates)
          Build a RelativeTabulatedAttitudeLeg with a reference date, a list of angular coordinates associated with a double representing the time elapsed since the reference date.
RelativeTabulatedAttitudeLeg(AbsoluteDate referenceDate, List<Pair<Double,AngularCoordinates>> angularCoordinates, int nbInterpolationPoints, Frame frame)
          Build a RelativeTabulatedAttitudeLeg with a reference date, a list of angular coordinates associated with a double representing the time elapsed since the reference date and a number of points used for interpolation.
RelativeTabulatedAttitudeLeg(AbsoluteDate referenceDate, List<Pair<Double,Rotation>> orientations, Frame frame)
          Build a RelativeTabulatedAttitudeLeg with a reference date, a list of Rotations associated with a double representing the time elapsed since the reference date.
RelativeTabulatedAttitudeLeg(AbsoluteDate referenceDate, List<Pair<Double,Rotation>> orientations, Frame frame, int nbInterpolationPoints)
          Build a RelativeTabulatedAttitudeLeg with a reference date, a list of Rotations associated with a double representing the time elapsed since the reference date and a number of points used for interpolation.
TargetPointing(Frame bodyFrame, Vector3D target)
          Creates a new instance from body frame and target expressed in cartesian coordinates.
 

Uses of Frame in org.orekit.attitudes.directions
 

Methods in org.orekit.attitudes.directions that return Frame
 Frame ConstantVectorDirection.getFrame()
           
 

Methods in org.orekit.attitudes.directions with parameters of type Frame
 Line IDirection.getLine(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
 Line NadirDirection.getLine(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
           
 Line MomentumDirection.getLine(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
 Line GlintApproximatePointingDirection.getLine(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
 Line EarthToCelestialBodyCenterDirection.getLine(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
 Line GenericTargetDirection.getLine(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
 Line ConstantVectorDirection.getLine(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the line containing the given origin point and directed by the direction vector
 Line EarthCenterDirection.getLine(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
 Line CrossProductDirection.getLine(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the cross product of directions.
 Line GroundVelocityDirection.getLine(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
           
 Line CelestialBodyPolesAxisDirection.getLine(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
 Line VelocityDirection.getLine(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
 Line ToCelestialBodyCenterDirection.getLine(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
 PVCoordinates ITargetDirection.getTargetPVCoordinates(AbsoluteDate date, Frame frame)
          Provides the target point at a given date in a given frame, represented by the associated PVCoordinates object
 PVCoordinates EarthToCelestialBodyCenterDirection.getTargetPVCoordinates(AbsoluteDate date, Frame frame)
          Provides the target point at a given date in a given frame, represented by the associated PVCoordinates object
 PVCoordinates GenericTargetDirection.getTargetPVCoordinates(AbsoluteDate date, Frame frame)
          Provides the target point at a given date in a given frame, represented by the associated PVCoordinates object
 PVCoordinates EarthCenterDirection.getTargetPVCoordinates(AbsoluteDate date, Frame frame)
          Provides the target point at a given date in a given frame, represented by the associated PVCoordinates object
 PVCoordinates ToCelestialBodyCenterDirection.getTargetPVCoordinates(AbsoluteDate date, Frame frame)
          Provides the target point at a given date in a given frame, represented by the associated PVCoordinates object
 Vector3D IDirection.getVector(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 Vector3D NadirDirection.getVector(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
           
 Vector3D MomentumDirection.getVector(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 Vector3D GlintApproximatePointingDirection.getVector(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 Vector3D EarthToCelestialBodyCenterDirection.getVector(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 Vector3D GenericTargetDirection.getVector(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 Vector3D ConstantVectorDirection.getVector(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 Vector3D EarthCenterDirection.getVector(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 Vector3D CrossProductDirection.getVector(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the cross product of direction1 vector and dirction2 vector.
 Vector3D GroundVelocityDirection.getVector(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
           
 Vector3D CelestialBodyPolesAxisDirection.getVector(PVCoordinatesProvider pvCoord, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 Vector3D VelocityDirection.getVector(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 Vector3D ToCelestialBodyCenterDirection.getVector(PVCoordinatesProvider origin, AbsoluteDate date, Frame frame)
          Provides the direction vector at a given date in a given frame.
 

Constructors in org.orekit.attitudes.directions with parameters of type Frame
ConstantVectorDirection(Vector3D inVector, Frame inFrame)
          Build a direction from a frame and a vector constant in this frame
VelocityDirection(Frame referenceFrame)
          Build a Direction defined for any PVCoordinatesProvider origin by its velocity vector with respect to a reference frame.
 

Uses of Frame in org.orekit.bodies
 

Fields in org.orekit.bodies declared as Frame
protected  Frame MeeusSun.MODEL.inertialSunFrame
          Sun inertially oriented frame.
 

Methods in org.orekit.bodies that return Frame
 Frame BodyShape.getBodyFrame()
          Get body frame related to body shape.
 Frame ExtendedOneAxisEllipsoid.getBodyFrame()
           
 Frame OneAxisEllipsoid.getBodyFrame()
          Get the body frame related to body shape.
 Frame CelestialBody.getBodyOrientedFrame()
          Get a body oriented, body centered frame.
 Frame AbstractCelestialBody.getBodyOrientedFrame()
          Get a body oriented, body centered frame.
 Frame CelestialBody.getFrame()
          Deprecated. as of 6.0 replaced by CelestialBody.getInertiallyOrientedFrame()
 Frame AbstractCelestialBody.getFrame()
          Deprecated. 
 Frame CelestialBody.getInertiallyOrientedFrame()
          Get an inertially oriented, body centered frame.
 Frame AbstractCelestialBody.getInertiallyOrientedFrame()
          Get an inertially oriented, body centered frame.
 

Methods in org.orekit.bodies with parameters of type Frame
 double GeometricBodyShape.distanceTo(Line line, Frame frame, AbsoluteDate date)
          Computes the distance to a line.
 double ExtendedOneAxisEllipsoid.distanceTo(Line line, Frame frame, AbsoluteDate date)
           
 GeodeticPoint BodyShape.getIntersectionPoint(Line line, Vector3D close, Frame frame, AbsoluteDate date)
          Get the intersection point of a line with the surface of the body.
 GeodeticPoint ExtendedOneAxisEllipsoid.getIntersectionPoint(Line line, Vector3D close, Frame frame, AbsoluteDate date)
           
 GeodeticPoint OneAxisEllipsoid.getIntersectionPoint(Line line, Vector3D close, Frame frame, AbsoluteDate date)
          Get the intersection point of a line with the surface of the body.
 Vector3D[] GeometricBodyShape.getIntersectionPoints(Line line, Frame frame, AbsoluteDate date)
          Compute the intersection points with a line.
 Vector3D[] ExtendedOneAxisEllipsoid.getIntersectionPoints(Line line, Frame frame, AbsoluteDate date)
           
 double GeometricBodyShape.getLocalRadius(Vector3D position, Frame frame, AbsoluteDate date, PVCoordinatesProvider occultedBody)
          Calculate the apparent radius.
 double ExtendedOneAxisEllipsoid.getLocalRadius(Vector3D position, Frame frame, AbsoluteDate date, PVCoordinatesProvider occultedBody)
          Calculate the apparent radius.
 PVCoordinates MeeusMoon.getPVCoordinates(AbsoluteDate date, Frame frame)
           
 PVCoordinates UserCelestialBody.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 PVCoordinates ExtendedOneAxisEllipsoid.getPVCoordinates(AbsoluteDate date, Frame frame)
           
 PVCoordinates MeeusSun.getPVCoordinates(AbsoluteDate date, Frame frame)
           
abstract  PVCoordinates AbstractCelestialBody.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 GeodeticPoint BodyShape.transform(Vector3D point, Frame frame, AbsoluteDate date)
          Transform a cartesian point to a surface-relative point.
 GeodeticPoint ExtendedOneAxisEllipsoid.transform(Vector3D point, Frame frame, AbsoluteDate date)
           
 GeodeticPoint OneAxisEllipsoid.transform(Vector3D point, Frame frame, AbsoluteDate date)
          Transform a cartesian point to a surface-relative point.
 GeodeticPoint OneAxisEllipsoid.transformAndComputeJacobian(Vector3D point, Frame frame, AbsoluteDate date, double[][] jacobian)
          Transform a cartesian point to a surface-relative point and compute the jacobian of the transformation.
static void MeeusSun.updateTransform(AbsoluteDate date, Frame frame)
          Update cached transform from FramesFactory.getMOD(boolean) to provided frame.
 

Constructors in org.orekit.bodies with parameters of type Frame
AbstractCelestialBody(String name, double gm, IAUPole iauPole, Frame definingFrame, String inertialFrameName, String bodyFrameName)
          Build an instance and the underlying frame.
ExtendedOneAxisEllipsoid(double ae, double f, Frame bodyFrame, String name)
          Constructor for the body spheroid.
OneAxisEllipsoid(double ae, double f, Frame bodyFrame)
          Simple constructor.
 

Uses of Frame in org.orekit.forces.atmospheres
 

Methods in org.orekit.forces.atmospheres with parameters of type Frame
 AtmosphereData DTM2000.getData(AbsoluteDate date, Vector3D position, Frame frame)
          Get detailed atmospheric data.
 AtmosphereData ExtendedAtmosphere.getData(AbsoluteDate date, Vector3D position, Frame frame)
          Get detailed atmospheric data.
 AtmosphereData MSISE2000.getData(AbsoluteDate date, Vector3D position, Frame frame)
          Get detailed atmospheric data.
 double DTM2000.getDensity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local density.
 double Atmosphere.getDensity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local density.
 double HarrisPriester.getDensity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local density.
 double SimpleExponentialAtmosphere.getDensity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local density.
 double MSISE2000.getDensity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local density.
 double US76.getDensity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local density for altitude in interval [0, 1E6] m
 double JB2006.getDensity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local density.
 double US76.getPress(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local pressure for altitude in interval [0, 1E6] m
 double DTM2000.getSpeedOfSound(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local speed of sound.
 double Atmosphere.getSpeedOfSound(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local speed of sound.
 double HarrisPriester.getSpeedOfSound(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local speed of sound.
 double SimpleExponentialAtmosphere.getSpeedOfSound(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local speed of sound.
 double MSISE2000.getSpeedOfSound(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local speed of sound.
 double US76.getSpeedOfSound(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local speed of sound.
 double JB2006.getSpeedOfSound(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local speed of sound.
 double US76.getTemp(AbsoluteDate date, Vector3D position, Frame frame)
          Get the local temperature for altitude in interval [0, 1E6] m
 Vector3D DTM2000.getVelocity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the inertial velocity of atmosphere molecules.
 Vector3D Atmosphere.getVelocity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the spacecraft velocity relative to the atmosphere.
 Vector3D HarrisPriester.getVelocity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the inertial velocity of atmosphere molecules.
 Vector3D SimpleExponentialAtmosphere.getVelocity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the spacecraft velocity relative to the atmosphere.
 Vector3D MSISE2000.getVelocity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the spacecraft velocity relative to the atmosphere.
 Vector3D US76.getVelocity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the spacecraft velocity relative to the atmosphere.
 Vector3D JB2006.getVelocity(AbsoluteDate date, Vector3D position, Frame frame)
          Get the inertial velocity of atmosphere molecules.
 

Uses of Frame in org.orekit.forces.drag
 

Methods in org.orekit.forces.drag with parameters of type Frame
static Vector3D DragForce.computeAcceleration(PVCoordinates pv, Frame frame, Atmosphere atm, AbsoluteDate date, double kD, double mass)
           Method to compute the acceleration.
 

Uses of Frame in org.orekit.forces.gravity
 

Methods in org.orekit.forces.gravity with parameters of type Frame
 Vector3D ThirdBodyAttraction.computeAcceleration(PVCoordinates pv, Frame frame, AbsoluteDate date)
           Method to compute the acceleration.
 Vector3D NewtonianAttraction.computeAcceleration(PVCoordinates pv, Frame frame, AbsoluteDate date)
           Method to compute the acceleration.
static Vector3D GravityToolbox.computeDrozinerAcceleration(PVCoordinates pv, Frame frame, double[][] coefficientsC, double[][] coefficientsS, double muc, double eqRadius, double threshold, int degree, int order)
          Method to compute the acceleration, from Droziner algorithm (see DrozinerAttractionModel).
 

Constructors in org.orekit.forces.gravity with parameters of type Frame
BalminoAttractionModel(Frame frame, double ae, double mu, double[][] Ccoefs, double[][] Scoefs)
          Create an instance of a normalized gravity computation model using normalized coefficients.
BalminoAttractionModel(Frame frame, double ae, double mu, double[][] Ccoefs, double[][] Scoefs, int degreePD, int orderPD)
          Create an instance of a normalized gravity computation model using normalized coefficients.
BalminoAttractionModel(Frame frame, Parameter ae, Parameter mu, double[][] Ccoefs, double[][] Scoefs)
          Create an instance of a normalized gravity computation model using normalized coefficients.
BalminoAttractionModel(Frame frame, Parameter ae, Parameter mu, double[][] Ccoefs, double[][] Scoefs, int degreePD, int orderPD)
          Create an instance of a normalized gravity computation model using normalized coefficients.
CunninghamAttractionModel(Frame centralBodyFrame, double equatorialRadius, double mu, double[][] C, double[][] S)
          Creates a new instance.
CunninghamAttractionModel(Frame centralBodyFrame, double equatorialRadius, double mu, double[][] C, double[][] S, int degreePD, int orderPD)
          Creates a new instance.
CunninghamAttractionModel(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, double[][] C, double[][] S)
          Creates a new instance using Parameter.
CunninghamAttractionModel(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, double[][] C, double[][] S, int degreePD, int orderPD)
          Creates a new instance using Parameter.
DrozinerAttractionModel(Frame centralBodyFrame, double equatorialRadius, double mu, double[][] C, double[][] S)
          Creates a new instance.
DrozinerAttractionModel(Frame centralBodyFrame, double equatorialRadius, double mu, double[][] C, double[][] S, boolean computePDPos, boolean computePDVel)
          Creates a new instance.
DrozinerAttractionModel(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, double[][] C, double[][] S)
          Creates a new instance using Parameter.
DrozinerAttractionModel(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, double[][] C, double[][] S, boolean computePDPos, boolean computePDVel)
          Creates a new instance using Parameter.
 

Uses of Frame in org.orekit.forces.gravity.tides
 

Fields in org.orekit.forces.gravity.tides declared as Frame
protected  Frame AbstractTides.bodyFrame
          Frame for the central body.
 

Methods in org.orekit.forces.gravity.tides with parameters of type Frame
 Vector3D AbstractTides.computeAcceleration(PVCoordinates pv, Frame frame, AbsoluteDate date)
           Method to compute the acceleration, from Balmino algorithm (see BalminoAttractionModel class).
 

Constructors in org.orekit.forces.gravity.tides with parameters of type Frame
AbstractTides(Frame centralBodyFrame, double equatorialRadius, double mu, int degree, int order)
          Build a new instance.
AbstractTides(Frame centralBodyFrame, double equatorialRadius, double mu, int degree, int order, int degreePD, int orderPD)
          Build a new instance.
AbstractTides(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, int degree, int order)
          Build a new instance using Parameter.
AbstractTides(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, int degree, int order, int degreePD, int orderPD)
          Build a new instance using Parameter.
OceanTides(Frame centralBodyFrame, double equatorialRadius, double mu, double density, int degree, int order, boolean withAdmittance, IOceanTidesDataProvider tidesData)
          Constructor.
OceanTides(Frame centralBodyFrame, double equatorialRadius, double mu, double density, int degree, int order, int degreePD, int orderPD, boolean withAdmittance, IOceanTidesDataProvider tidesData)
          Constructor.
OceanTides(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, Parameter density, int degree, int order, boolean withAdmittance, IOceanTidesDataProvider tidesData)
          Constructor using Parameter.
OceanTides(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, Parameter density, int degree, int order, int degreePD, int orderPD, boolean withAdmittance, IOceanTidesDataProvider tidesData)
          Constructor using Parameter.
TerrestrialTides(Frame centralBodyFrame, double equatorialRadius, double mu)
          Creates a new instance.
TerrestrialTides(Frame centralBodyFrame, double equatorialRadius, double mu, boolean computePD)
          Creates a new instance.
TerrestrialTides(Frame centralBodyFrame, double equatorialRadius, double mu, List<CelestialBody> bodies, boolean thirdBodyAttDegree3, boolean frequencyCorr, boolean ellipticityCorr, ITerrestrialTidesDataProvider terrestrialData)
          Creates a new instance.
TerrestrialTides(Frame centralBodyFrame, double equatorialRadius, double mu, List<CelestialBody> bodies, boolean thirdBodyAttDegree3, boolean frequencyCorr, boolean ellipticityCorr, ITerrestrialTidesDataProvider terrestrialData, boolean computePD)
          Creates a new instance.
TerrestrialTides(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu)
          Creates a new instance.
TerrestrialTides(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, boolean computePD)
          Creates a new instance.
TerrestrialTides(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, List<CelestialBody> bodies, boolean thirdBodyAttDegree3, boolean frequencyCorr, boolean ellipticityCorr, ITerrestrialTidesDataProvider terrestrialData)
          Creates a new instance using Parameter.
TerrestrialTides(Frame centralBodyFrame, Parameter equatorialRadius, Parameter mu, List<CelestialBody> bodies, boolean thirdBodyAttDegree3, boolean frequencyCorr, boolean ellipticityCorr, ITerrestrialTidesDataProvider terrestrialData, boolean computePD)
          Creates a new instance using Parameter.
 

Uses of Frame in org.orekit.forces.gravity.variations
 

Constructors in org.orekit.forces.gravity.variations with parameters of type Frame
VariablePotentialAttractionModel(Frame centralBodyFrame, VariablePotentialCoefficientsProvider provider, int degree, int order)
          Variable gravity field force model constructor (static part only).
VariablePotentialAttractionModel(Frame centralBodyFrame, VariablePotentialCoefficientsProvider provider, int degree, int order, int degreePD, int orderPD)
          Variable gravity field force model constructor (static part only).
VariablePotentialAttractionModel(Frame centralBodyFrame, VariablePotentialCoefficientsProvider provider, int degree, int order, int degreeOptional, int orderOptional, boolean computeOptionalOnce)
          Variable gravity field force model constructor.
VariablePotentialAttractionModel(Frame centralBodyFrame, VariablePotentialCoefficientsProvider provider, int degree, int order, int degreePD, int orderPD, int degreeOptional, int orderOptional, int degreeOptionalPD, int orderOptionalPD, boolean computeOptionalOnce)
          Variable gravity field force model constructor.
 

Uses of Frame in org.orekit.forces.maneuvers
 

Methods in org.orekit.forces.maneuvers that return Frame
 Frame ImpulseManeuver.getFrame()
          Get the frame of the velocity increment.
 Frame SmallManeuverAnalyticalModel.getInertialFrame()
          Get the inertial frame in which the velocity increment is defined.
 

Constructors in org.orekit.forces.maneuvers with parameters of type Frame
ConstantThrustError(AbsoluteDate date, double duration, Frame frame, double cx, double cy, double cz)
          Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(AbsoluteDate date, double duration, Frame frame, double ax, double bx, double ay, double by, double az, double bz, AbsoluteDate date0)
          Create a constant thrust error model whose x, y and z components are linear functions:
fx = ax*t + bx
fy = ay*t + by
fz = az*t + bz
ConstantThrustError(AbsoluteDate date, double duration, Frame frame, IParamDiffFunction fx, IParamDiffFunction fy, IParamDiffFunction fz)
          Create a constant thrust error model whose x, y and z components are parameterizable and differentiable function.
ConstantThrustError(AbsoluteDate date, double duration, Frame frame, Parameter cx, Parameter cy, Parameter cz)
          Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(AbsoluteDate date, double duration, Frame frame, Parameter ax, Parameter bx, Parameter ay, Parameter by, Parameter az, Parameter bz, AbsoluteDate date0)
          Create a constant thrust error model whose x, y and z components are linear functions:
fx = ax*t + bx
fy = ay*t + by
fz = az*t + bz
ConstantThrustError(EventDetector startEventDetector, EventDetector stopEventDetector, Frame frame, IParamDiffFunction fx, IParamDiffFunction fy, IParamDiffFunction fz)
          Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(EventDetector startEventDetector, EventDetector stopEventDetector, Frame frame, Parameter cx, Parameter cy, Parameter cz)
          Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ImpulseManeuver(EventDetector trigger, Vector3D deltaVSat, Frame frame, double isp, MassProvider massModel, String part)
          Build a new instance.
SmallManeuverAnalyticalModel(SpacecraftState state0, Frame frame, Vector3D dV, double isp, String partName)
          Build a maneuver defined in user-specified frame.
 

Uses of Frame in org.orekit.forces.radiation
 

Methods in org.orekit.forces.radiation with parameters of type Frame
 double SolarRadiationPressure.getLightningRatio(Vector3D position, Frame frame, AbsoluteDate date)
          Get the lightning ratio ([0-1]).
 

Constructors in org.orekit.forces.radiation with parameters of type Frame
RediffusedFlux(int nCorona, int nMeridian, Frame bodyFrame, CelestialBody sunProvider, PVCoordinatesProvider satProvider, AbsoluteDate d, IEmissivityModel model)
          Default constructor of rediffused flux.
RediffusedFlux(int nCorona, int nMeridian, Frame bodyFrame, CelestialBody sun, PVCoordinatesProvider satProvider, AbsoluteDate dDate, IEmissivityModel model, boolean inIr, boolean inAlbedo)
          Generic constructor of rediffused flux.
RediffusedRadiationPressure(CelestialBody inSun, Frame inBodyFrame, int inCorona, int inMeridian, IEmissivityModel inEmissivityModel, RediffusedRadiationSensitive inModel)
          Constructor.
RediffusedRadiationPressure(CelestialBody inSun, Frame inBodyFrame, int inCorona, int inMeridian, IEmissivityModel inEmissivityModel, RediffusedRadiationSensitive inModel, boolean computePD)
          Constructor.
 

Uses of Frame in org.orekit.forces.relativistic
 

Constructors in org.orekit.forces.relativistic with parameters of type Frame
LenseThirringRelativisticEffect(double mu, Frame frame)
          Constructor and with partial derivative computation by default.
LenseThirringRelativisticEffect(double mu, Frame frame, boolean computePartialDerivativesPos, boolean computePartialDerivativesVel)
          Constructor.
 

Uses of Frame in org.orekit.frames
 

Subclasses of Frame in org.orekit.frames
 class FactoryManagedFrame
          Base class for the predefined frames that are managed by FramesFactory.
 class H0MinusNFrame
          "H0 - n" reference frame.
 class LocalOrbitalFrame
          Class for frames moving with an orbiting satellite.
 class SpacecraftFrame
          Deprecated. as of 6.0 replaced by SpacecraftState.toTransform()
 class TopocentricFrame
          Topocentric frame.
 class UpdatableFrame
          Frame whose transform from its parent can be updated.
 

Methods in org.orekit.frames that return Frame
protected  Frame Frame.getAncestor(int n)
          Get the nth ancestor of the frame.
static Frame FramesFactory.getFrame(Predefined factoryKey)
          Get one of the predefined frames.
 Frame Frame.getFrozenFrame(Frame reference, AbsoluteDate freezingDate, String frozenName)
          Get a new version of the instance, frozen with respect to a reference frame.
static Frame FramesFactory.getGCRF()
          Get the unique GCRF frame.
static Frame FramesFactory.getH0MinusN(String name, AbsoluteDate h0MinusN, double longitude)
          Get the "H0 - n" reference frame.
static Frame FramesFactory.getH0MinusN(String name, AbsoluteDate h0, double n, double longitude)
          Get the "H0 - n" reference frame.
static Frame FramesFactory.getICRF()
          Get the unique ICRF frame.
static Frame OrphanFrame.getNewOrphanFrame(String name)
          This method creates an Orphan Frame.
 Frame Frame.getParent()
          Get the parent frame.
protected static Frame Frame.getRoot()
          Get the unique root frame.
 

Methods in org.orekit.frames with parameters of type Frame
 double TopocentricFrame.getAzimuth(Vector3D extPoint, Frame frame, AbsoluteDate date)
          Get the azimuth of a point with regards to the topocentric frame center point.
 double TopocentricFrame.getAzimuthRate(PVCoordinates extPV, Frame frame, AbsoluteDate date)
          Get the azimuth rate of a point.
 double TopocentricFrame.getElevation(Vector3D extPoint, Frame frame, AbsoluteDate date)
          Get the elevation of a point with regards to the local point.
 double TopocentricFrame.getElevationRate(PVCoordinates extPV, Frame frame, AbsoluteDate date)
          Get the elevation rate of a point.
 Frame Frame.getFrozenFrame(Frame reference, AbsoluteDate freezingDate, String frozenName)
          Get a new version of the instance, frozen with respect to a reference frame.
 PVCoordinates SpacecraftFrame.getPVCoordinates(AbsoluteDate date, Frame frame)
          Deprecated. Get the PVCoordinates of the spacecraft frame origin in the selected frame.
 PVCoordinates TopocentricFrame.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the topocentric frame origin in the selected frame.
 double TopocentricFrame.getRange(Vector3D extPoint, Frame frame, AbsoluteDate date)
          Get the range of a point with regards to the topocentric frame center point.
 double TopocentricFrame.getRangeRate(PVCoordinates extPV, Frame frame, AbsoluteDate date)
          Get the range rate of a point with regards to the topocentric frame center point.
 RealMatrix Frame.getTransformJacobian(Frame to, AbsoluteDate date)
          Compute the Jacobian from current frame to target frame at provided date.
 Transform Frame.getTransformTo(Frame destination, AbsoluteDate date)
          Get the transform from the instance to another frame.
 Transform Frame.getTransformTo(Frame destination, AbsoluteDate date, boolean computeSpinDerivatives)
          Get the transform from the instance to another frame.
 Transform Frame.getTransformTo(Frame destination, AbsoluteDate date, FramesConfiguration config)
          Get the transform from the instance to another frame.
 Transform Frame.getTransformTo(Frame destination, AbsoluteDate date, FramesConfiguration config, boolean computeSpinDerivatives)
          Get the transform from the instance to another frame.
 double TopocentricFrame.getXangleCardan(Vector3D extPoint, Frame frame, AbsoluteDate date)
          Get the Cardan x angle of a point.
 double TopocentricFrame.getXangleCardanRate(PVCoordinates extPV, Frame frame, AbsoluteDate date)
          Get the Cardan x angle rate.
 double TopocentricFrame.getYangleCardan(Vector3D extPoint, Frame frame, AbsoluteDate date)
          Get the Cardan y angle of a point with regards to the projection point on the plane defined by the zenith and the west axis.
 double TopocentricFrame.getYangleCardanRate(PVCoordinates extPV, Frame frame, AbsoluteDate date)
          Get the Cardan y angle rate.
 boolean Frame.isChildOf(Frame potentialAncestor)
          Determine if a Frame is a child of another one.
 CardanMountPosition TopocentricFrame.transformFromPositionToCardan(Vector3D extPoint, Frame frame, AbsoluteDate date)
          Transform a Cartesian position coordinates into Cardan mounting in this local topocentric frame.
 TopocentricPosition TopocentricFrame.transformFromPositionToTopocentric(Vector3D extPoint, Frame frame, AbsoluteDate date)
          Transform a Cartesian position coordinates into topocentric coordinates in this local topocentric frame.
 CardanMountPV TopocentricFrame.transformFromPVToCardan(PVCoordinates extPV, Frame frame, AbsoluteDate date)
          Transform a Cartesian position coordinates into Cardan mounting in this local topocentric frame.
 TopocentricPV TopocentricFrame.transformFromPVToTopocentric(PVCoordinates extPV, Frame frame, AbsoluteDate date)
          Transform a Cartesian position and velocity coordinates into topocentric coordinates in this local topocentric frame.
 void UpdatableFrame.updateTransform(Frame f1, Frame f2, Transform f1Tof2, AbsoluteDate date)
          Update the transform from parent frame implicitly according to two other frames.
 

Constructors in org.orekit.frames with parameters of type Frame
FactoryManagedFrame(Frame parent, TransformProvider transformProvider, boolean pseudoInertial, Predefined factoryKey)
          Simple constructor.
Frame(Frame parent, TransformProvider transformProvider, String name)
          Build a non-inertial frame from its transform with respect to its parent.
Frame(Frame parent, TransformProvider transformProvider, String name, boolean pseudoInertial)
          Build a frame from its transform with respect to its parent.
Frame(Frame parent, Transform transform, String name)
          Build a non-inertial frame from its transform with respect to its parent.
Frame(Frame parent, Transform transform, String name, boolean pseudoInertial)
          Build a frame from its transform with respect to its parent.
LocalOrbitalFrame(Frame parent, LOFType type, PVCoordinatesProvider provider, String name)
          Build a new instance.
UpdatableFrame(Frame parent, Transform transform, String name)
          Build a non-inertial frame from its transform with respect to its parent.
UpdatableFrame(Frame parent, Transform transform, String name, boolean pseudoInertial)
          Build a frame from its transform with respect to its parent.
 

Uses of Frame in org.orekit.models.earth
 

Methods in org.orekit.models.earth with parameters of type Frame
 GeoMagneticElements GeoMagneticField.calculateField(Vector3D point, Frame frame, AbsoluteDate date)
          Calculate the magnetic field at the specified point identified by the coordinates of the point and the reference point.
 

Uses of Frame in org.orekit.orbits
 

Methods in org.orekit.orbits that return Frame
 Frame Orbit.getFrame()
          Get the frame in which the orbital parameters are defined.
 

Methods in org.orekit.orbits with parameters of type Frame
abstract  Orbit OrbitType.convertOrbit(Orbit initOrbit, Frame frame)
          Convert an orbit from a given orbit type to an other in a wished frame.
 PVCoordinates Orbit.getPVCoordinates(AbsoluteDate otherDate, Frame otherFrame)
          Get the PVCoordinates of the body in the selected frame.
 PVCoordinates Orbit.getPVCoordinates(Frame outputFrame)
          Get the PVCoordinates in a specified frame.
abstract  Orbit OrbitType.mapArrayToOrbit(double[] array, PositionAngle type, AbsoluteDate date, double mu, Frame frame)
          Convert state array to orbital parameters.
 

Constructors in org.orekit.orbits with parameters of type Frame
ApsisOrbit(double peri, double apo, double i, double pa, double raan, double anomaly, PositionAngle type, Frame frame, AbsoluteDate date, double mu)
          Creates a new instance.
ApsisOrbit(IOrbitalParameters parameters, Frame frame, AbsoluteDate date)
          Creates a new instance.
ApsisOrbit(PVCoordinates pvCoordinates, Frame frame, AbsoluteDate date, double mu)
          Constructor from cartesian parameters.
CartesianOrbit(IOrbitalParameters parameters, Frame frame, AbsoluteDate date)
          Creates a new instance.
CartesianOrbit(PVCoordinates pvCoordinates, Frame frame, AbsoluteDate date, double mu)
          Constructor from cartesian parameters.
CircularOrbit(double a, double ex, double ey, double i, double raan, double alpha, int type, Frame frame, AbsoluteDate date, double mu)
          Deprecated. as of 6.0 replaced by CircularOrbit.CircularOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double)
CircularOrbit(double a, double ex, double ey, double i, double raan, double alpha, PositionAngle type, Frame frame, AbsoluteDate date, double mu)
          Creates a new instance.
CircularOrbit(IOrbitalParameters parameters, Frame frame, AbsoluteDate date)
          Creates a new instance.
CircularOrbit(PVCoordinates pvCoordinates, Frame frame, AbsoluteDate date, double mu)
          Constructor from cartesian parameters.
EquatorialOrbit(double a, double e, double pomega, double ix, double iy, double anomaly, PositionAngle type, Frame frame, AbsoluteDate date, double mu)
          Creates a new instance.
EquatorialOrbit(IOrbitalParameters parameters, Frame frame, AbsoluteDate date)
          Creates a new instance.
EquatorialOrbit(PVCoordinates pvCoordinates, Frame frame, AbsoluteDate date, double mu)
          Constructor from cartesian parameters.
EquinoctialOrbit(double a, double ex, double ey, double hx, double hy, double l, int type, Frame frame, AbsoluteDate date, double mu)
          Deprecated. as of 6.0 replaced by EquinoctialOrbit.EquinoctialOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double)
EquinoctialOrbit(double a, double ex, double ey, double hx, double hy, double l, PositionAngle type, Frame frame, AbsoluteDate date, double mu)
          Creates a new instance.
EquinoctialOrbit(IOrbitalParameters parameters, Frame frame, AbsoluteDate date)
          Creates a new instance.
EquinoctialOrbit(PVCoordinates pvCoordinates, Frame frame, AbsoluteDate date, double mu)
          Constructor from cartesian parameters.
KeplerianOrbit(double a, double e, double i, double pa, double raan, double anomaly, int type, Frame frame, AbsoluteDate date, double mu)
          Deprecated. as of 6.0 replaced by KeplerianOrbit.KeplerianOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double)
KeplerianOrbit(double a, double e, double i, double pa, double raan, double anomaly, PositionAngle type, Frame frame, AbsoluteDate date, double mu)
          Creates a new instance.
KeplerianOrbit(IOrbitalParameters parameters, Frame frame, AbsoluteDate date)
          Creates a new instance.
KeplerianOrbit(PVCoordinates pvCoordinates, Frame frame, AbsoluteDate date, double mu)
          Constructor from cartesian parameters.
Orbit(Frame frame, AbsoluteDate date, double mu)
          Default constructor.
Orbit(PVCoordinates pvCoordinates, Frame frame, AbsoluteDate date, double mu)
          Set the orbit from Cartesian parameters.
 

Uses of Frame in org.orekit.propagation
 

Methods in org.orekit.propagation that return Frame
 Frame AnalyticalIntegratedEphemeris.getFrame()
          Get the frame in which the orbit is propagated.
 Frame Propagator.getFrame()
          Get the frame in which the orbit is propagated.
 Frame SpacecraftState.getFrame()
          Get the inertial frame.
 Frame AbstractPropagator.getFrame()
          Get the frame in which the orbit is propagated.
 

Methods in org.orekit.propagation with parameters of type Frame
 Attitude SpacecraftState.getAttitude(Frame outputFrame)
          Get the default attitude : the attitude for forces computation in given output frame.
 Attitude SpacecraftState.getAttitudeEvents(Frame outputFrame)
          Get the attitude for events computation in given output frame.
 Attitude SpacecraftState.getAttitudeForces(Frame outputFrame)
          Get the attitude for forces computation in given output frame.
 PVCoordinates AbstractPropagator.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 PVCoordinates SpacecraftState.getPVCoordinates(Frame outputFrame)
          Get the PVCoordinates in given output frame.
 void Propagator.setOrbitFrame(Frame frame)
          Set propagation frame.
 void AbstractPropagator.setOrbitFrame(Frame frame)
          Set propagation frame.
 Transform SpacecraftState.toTransform(Frame frame)
          Compute the transform from specified frame to spacecraft frame.
 Transform SpacecraftState.toTransform(Frame frame, LOFType lofType)
          Compute the transform from specified frame to local orbital frame.
 Transform SpacecraftState.toTransformEvents(Frame frame)
          Compute the transform from specified reference frame to spacecraft frame.
 Transform SpacecraftState.toTransformForces(Frame frame)
          Compute the transform from specified frame to spacecraft frame.
 

Constructors in org.orekit.propagation with parameters of type Frame
SpacecraftState(double[] y, OrbitType orbitType, PositionAngle angleType, AbsoluteDate date, double mu, Frame frame, Map<String,AdditionalStateInfo> addStatesInfo, AttitudeProvider attProviderForces, AttitudeProvider attProviderEvents)
          Build a spacecraft from an array (a state vector) and an additional states informations map.
 

Uses of Frame in org.orekit.propagation.analytical
 

Methods in org.orekit.propagation.analytical with parameters of type Frame
protected  Orbit AbstractLyddanePropagator.convertFrame(Orbit orbit, Frame outputFrame)
          Convert provided orbit in output frame.
protected  Orbit AbstractLyddanePropagator.propagateOrbit(AbsoluteDate date, Orbit secularOrbit, Frame outputFrame, AbstractLyddanePropagator.LyddaneParametersType returnType)
          Propagate orbit to provided date.
 

Constructors in org.orekit.propagation.analytical with parameters of type Frame
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.
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.
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 Frame in org.orekit.propagation.analytical.covariance
 

Methods in org.orekit.propagation.analytical.covariance with parameters of type Frame
 SymmetricMatrix OrbitCovariance.getCovarianceMatrix(Orbit refOrbit, OrbitType outCovType, Frame outFrame)
          Covariance matrix getter.
 

Constructors in org.orekit.propagation.analytical.covariance with parameters of type Frame
OrbitCovariance(AbsoluteDate covDate, Frame refFrame, OrbitType coordType, RealMatrix covMat)
          Simple constructor
 

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

Methods in org.orekit.propagation.analytical.tle that return Frame
 Frame TLEPropagator.getFrame()
          Get the frame in which the orbit is propagated.
 

Uses of Frame in org.orekit.propagation.events
 

Methods in org.orekit.propagation.events that return Frame
 Frame AOLDetector.getAOLFrame()
          Get the reference frame.
 Frame ExtremaLatitudeDetector.getBodyFrame()
          Returns the body frame.
 Frame ExtremaLongitudeDetector.getBodyFrame()
          Returns the body frame.
 Frame LongitudeDetector.getBodyFrame()
          Returns central body frame.
 Frame NodeDetector.getFrame()
          Get the frame in which the equator is defined.
 

Methods in org.orekit.propagation.events with parameters of type Frame
 double ConstantRadiusProvider.getLocalRadius(Vector3D position, Frame frame, AbsoluteDate date, PVCoordinatesProvider occultedBodyIn)
          Calculate the apparent radius.
 double VariableRadiusProvider.getLocalRadius(Vector3D position, Frame frame, AbsoluteDate date, PVCoordinatesProvider occultedBodyIn)
          Calculate the apparent radius.
 double LocalRadiusProvider.getLocalRadius(Vector3D position, Frame frame, AbsoluteDate date, PVCoordinatesProvider occultedBodyIn)
          Calculate the apparent radius.
 

Constructors in org.orekit.propagation.events with parameters of type Frame
AdaptedEventDetector(EventDetector detector, Map<String,AdditionalStateInfo> info, OrbitType orbitType, PositionAngle angleType, AttitudeProvider attProviderForces, AttitudeProvider attProviderEvents, AbsoluteDate referenceDate, double mu, Frame integrationFrame)
          Build a wrapped event detector.
AOLDetector(double angle, PositionAngle type, Frame equator)
          Constructor for an AOLDetector instance.
AOLDetector(double angle, PositionAngle type, Frame equator, double maxCheck, double threshold)
          Constructor for an AOLDetector instance with complementary parameters.
AOLDetector(double angle, PositionAngle type, Frame equator, double maxCheck, double threshold, EventDetector.Action action)
          Constructor for an AOLDetector instance with complementary parameters.
AOLDetector(double angle, PositionAngle type, Frame equator, double maxCheck, double threshold, EventDetector.Action action, boolean remove)
          Constructor for an AOLDetector instance with complementary parameters.
ExtremaLatitudeDetector(int extremumType, Frame bodyFrame)
          Constructor for a ExtremaLatitudeDetector instance.
ExtremaLatitudeDetector(int extremumType, Frame bodyFrame, double maxCheck, double threshold)
          Constructor for a ExtremaLatitudeDetector instance.
ExtremaLatitudeDetector(int extremumType, Frame bodyFrame, double maxCheck, double threshold, EventDetector.Action action)
          Constructor for a ExtremaLatitudeDetector instance.
ExtremaLatitudeDetector(int extremumType, Frame bodyFrame, double maxCheck, double threshold, EventDetector.Action action, boolean remove)
          Constructor for a ExtremaLatitudeDetector instance.
ExtremaLongitudeDetector(int extremumType, Frame bodyFrame)
          Constructor for a ExtremaLongitudeDetector instance.
ExtremaLongitudeDetector(int extremumType, Frame bodyFrame, double maxCheck, double threshold)
          Constructor for a ExtremaLongitudeDetector instance.
ExtremaLongitudeDetector(int extremumType, Frame bodyFrame, double maxCheck, double threshold, EventDetector.Action action)
          Constructor for a ExtremaLongitudeDetector instance.
ExtremaLongitudeDetector(int extremumType, Frame bodyFrame, double maxCheck, double threshold, EventDetector.Action action, boolean remove)
          Constructor for a ExtremaLongitudeDetector instance.
LongitudeDetector(double longitudeToDetect, Frame bodyFrame)
          Constructor for the longitude detector.
LongitudeDetector(double longitudeToDetect, Frame bodyFrame, double maxCheck, double threshold)
          Constructor for the longitude detector.
LongitudeDetector(double longitudeToDetect, Frame bodyFrame, double maxCheck, double threshold, EventDetector.Action action)
          Constructor for the longitude detector.
LongitudeDetector(double longitudeToDetect, Frame bodyFrame, double maxCheck, double threshold, EventDetector.Action action, boolean remove)
          Constructor for the longitude detector.
NodeDetector(Frame frame, double maxCheck, double threshold, EventDetector.Action ascendingNode, EventDetector.Action descendingNode)
          Build a new instance for both ascending and descending node detection.
NodeDetector(Frame frame, double maxCheck, double threshold, EventDetector.Action ascendingNode, EventDetector.Action descendingNode, boolean removeAscendingNode, boolean removeDescendingNode)
          Build a new instance for both ascending and descending node detection.
NodeDetector(Frame frame, int slopeSelection, double maxCheck, double threshold)
          Build a new instance.
NodeDetector(Frame frame, int slopeSelection, double maxCheck, double threshold, EventDetector.Action action)
          Build a new instance.
NodeDetector(Frame frame, int slopeSelection, double maxCheck, double threshold, EventDetector.Action action, boolean removeCrossingNode)
          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 Frame in org.orekit.propagation.numerical
 

Methods in org.orekit.propagation.numerical that return Frame
 Frame NumericalPropagator.getFrame()
          Get the frame in which the orbit is propagated.
 

Methods in org.orekit.propagation.numerical with parameters of type Frame
 void TimeDerivativesEquations.addAcceleration(Vector3D gamma, Frame frame)
          Add the contribution of an acceleration expressed in some inertial frame.
 PVCoordinates NumericalPropagator.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 void ModeHandler.initialize(OrbitType orbit, PositionAngle angle, AttitudeProvider attitudeProviderForces, AttitudeProvider attitudeProviderEvents, Map<String,AdditionalStateInfo> additionalStateInfos, boolean activateHandlers, AbsoluteDate reference, Frame frame, double mu)
          Initialize the mode handler.
 void NumericalPropagator.setOrbitFrame(Frame frame)
          Set propagation frame.
 

Uses of Frame in org.orekit.propagation.precomputed
 

Fields in org.orekit.propagation.precomputed declared as Frame
protected  Frame AbstractEphemeris.frame
          Reference frame.
 

Methods in org.orekit.propagation.precomputed with parameters of type Frame
static SpacecraftState[] AbstractEphemeris.generateSpacecraftState(PVCoordinatesProvider pvProv, AttitudeProvider attProvForces, AttitudeProvider attProvEvents, double step, AbsoluteDateInterval ptsInterval, Frame frame, double mu)
          Creates a spacecraft array with constant step size.
 PVCoordinates IntegratedEphemeris.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 PVCoordinates Ephemeris.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 

Constructors in org.orekit.propagation.precomputed with parameters of type Frame
HermiteEphemeris(PVCoordinatesProvider pvProv, AttitudeProvider attProvForces, AttitudeProvider attProvEvents, double step, AbsoluteDateInterval intervalOfPoints, Frame frame2, double mu2)
          Deprecated. Constructor n°1 using a PV coordinates provider and an AttitudeProvider to build the interpolation points.
IntegratedEphemeris(List<AbsoluteDate> startDates, List<AbsoluteDate> minDates, List<AbsoluteDate> maxDates, OrbitType orbitType, PositionAngle angleType, AttitudeProvider attitudeForcesProvider, AttitudeProvider attitudeEventsProvider, Map<String,AdditionalStateInfo> additionalStateInfos, List<ContinuousOutputModel> models, Frame referenceFrame, double mu)
          Creates a new instance of IntegratedEphemeris.
LagrangeEphemeris(PVCoordinatesProvider pvProv, AttitudeProvider attProvForces, AttitudeProvider attProvEvents, double step, AbsoluteDateInterval intervalOfPoints, Frame frame, double mu)
          Deprecated. Constructor using a PV coordinates provider and an AttitudeProvider to build the interpolation points, defaulting to 8th order for the Lagrange interpolator.
LagrangeEphemeris(PVCoordinatesProvider pvProv, AttitudeProvider attProvForces, AttitudeProvider attProvEvents, double step, AbsoluteDateInterval intervalOfPoints, Frame frame, double mu, int order)
          Deprecated. Constructor using a PV coordinates provider and an AttitudeProvider to build the interpolation points.
 

Uses of Frame in org.orekit.propagation.sampling
 

Methods in org.orekit.propagation.sampling with parameters of type Frame
 void AdaptedStepHandler.initialize(OrbitType orbit, PositionAngle angle, AttitudeProvider attitudeProviderForces, AttitudeProvider attitudeProviderEvents, Map<String,AdditionalStateInfo> additionalStateInfos, boolean activateHandlers, AbsoluteDate reference, Frame frame, double mu)
          Initialize the mode handler.
 

Uses of Frame in org.orekit.time
 

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

Uses of Frame in org.orekit.utils
 

Methods in org.orekit.utils that return Frame
 Frame AbstractBoundedPVProvider.getFrame()
          Get the reference frame
 

Methods in org.orekit.utils with parameters of type Frame
 PVCoordinates PVCoordinatesProvider.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 PVCoordinates EphemerisPvLagrange.getPVCoordinates(AbsoluteDate date, Frame frame)
          Frame can be null : by default the frame of expression is the frame used at instantiation (which is the frame of the first spacecraft state when instantiation is done from a table of spacecraft states).
 PVCoordinates EphemerisPvHermite.getPVCoordinates(AbsoluteDate date, Frame frame)
          Get the PVCoordinates of the body in the selected frame.
 

Constructors in org.orekit.utils with parameters of type Frame
AbstractBoundedPVProvider(PVCoordinates[] tabPV, int order, Frame frame, AbsoluteDate[] tabDate, ISearchIndex algo)
          Instantiation of AbstractBoundedPVProvider attributes.
EphemerisPvHermite(PVCoordinates[] tabPV, int order, Vector3D[] tabAcc, Frame frame, AbsoluteDate[] tabDate, ISearchIndex algo)
          Creates an instance of EphemerisPvHermite.
EphemerisPvHermite(PVCoordinates[] tabPV, Vector3D[] tabAcc, Frame frame, AbsoluteDate[] tabDate, ISearchIndex algo)
          Creates an instance of EphemerisPvHermite with default interpolation order = 2.
EphemerisPvLagrange(PVCoordinates[] tabPV, int order, Frame frame, AbsoluteDate[] tabDate, ISearchIndex algo)
          Creates an instance of EphemerisPvLagrange
 

Uses of Frame in org.orekit.wrenches
 

Methods in org.orekit.wrenches with parameters of type Frame
 Vector3D WrenchModel.computeTorque(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 Wrench WrenchModel.computeWrench(SpacecraftState s, Vector3D origin, Frame frame)
          Compute the resulting wrench.
 



Copyright © 2017 CNES. All Rights Reserved.