Modifier and Type | Method and Description |
---|---|
PVCoordinates |
SensorModel.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the sensor part in the selected frame. |
Modifier and Type | Method and Description |
---|---|
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 |
ToCelestialBodyCenterDirection.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 |
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 |
EarthCenterDirection.getTargetPVCoordinates(AbsoluteDate date,
Frame frame)
Provides the target point at a given date in a given frame, represented by the
associated PVCoordinates object
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
PosVelChebyshev.getPositionVelocity(AbsoluteDate date)
Get the position-velocity at a specified date.
|
PVCoordinates |
MeeusSun.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 |
MeeusMoon.getPVCoordinates(AbsoluteDate date,
Frame frame) |
abstract PVCoordinates |
AbstractCelestialBody.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the body in the selected frame. |
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
SatelliteTimeCoordinate.getCoordinate()
Returns the coordinate of this entry.
|
Modifier and Type | Method and Description |
---|---|
void |
SatelliteTimeCoordinate.setCoordinate(PVCoordinates coordinateIn)
Set the coordinate for this entry.
|
Constructor and Description |
---|
SatelliteTimeCoordinate(AbsoluteDate time,
PVCoordinates coord)
Creates a new
SatelliteTimeCoordinate instance with
a given epoch and coordinate. |
SatelliteTimeCoordinate(AbsoluteDate time,
PVCoordinates coord,
double clockCorr,
double rateChange)
Creates a new
SatelliteTimeCoordinate instance with a given
epoch, coordinate and clock value / rate change. |
Modifier and Type | Method and Description |
---|---|
Vector3D |
EmpiricalForce.computeAcceleration(PVCoordinates pv,
LocalOrbitalFrame localFrameValidation,
Vector3D vectorS,
Frame frame,
SpacecraftState state)
Method to compute the acceleration.
|
double[] |
EmpiricalForce.computeCosSin(PVCoordinates pv,
Vector3D vectorS)
Private method to compute the cos(nwt) and sin(nwt) values.
|
Modifier and Type | Method and Description |
---|---|
static Vector3D |
DragForce.computeAcceleration(PVCoordinates pv,
Frame frame,
Atmosphere atm,
AbsoluteDate date,
double kD,
double mass)
Method to compute the acceleration.
|
Modifier and Type | Method and Description |
---|---|
Vector3D |
BalminoAttractionModel.computeAcceleration(PVCoordinates pv)
Acceleration in body frame.
|
Vector3D |
DrozinerAttractionModel.computeAcceleration(PVCoordinates pv,
AbsoluteDate date)
Method to compute the acceleration.
|
Vector3D |
CunninghamAttractionModel.computeAcceleration(PVCoordinates pv,
AbsoluteDate date)
Method to compute the acceleration.
|
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.computeBalminoAcceleration(PVCoordinates pv,
double[][] coefficientsC,
double[][] coefficientsS,
double muc,
double eqRadius,
int degree,
int order,
HelmholtzPolynomial helm)
Method to compute the acceleration, from Balmino algorithm (see
BalminoAttractionModel ). |
static Vector3D |
GravityToolbox.computeCunninghamAcceleration(PVCoordinates pv,
double equatorialRadius,
double[][] coefC,
double[][] coefS,
int degree,
int order,
double mu)
Method to compute the acceleration.
|
static double[][] |
GravityToolbox.computeDAccDPos(PVCoordinates pv,
AbsoluteDate date,
double equatorialRadius,
double mu,
double[][] c,
double[][] s)
Compute the partial derivatives of the acceleration (Cunningham algorithm) with respect to the position.
|
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 ). |
Modifier and Type | Method and Description |
---|---|
Vector3D |
AbstractTides.computeAcceleration(PVCoordinates pv,
Frame frame,
AbsoluteDate date)
Method to compute the acceleration, from Balmino algorithm (see BalminoAttractionModel class).
|
Modifier and Type | Method and Description |
---|---|
Vector3D |
VariablePotentialAttractionModel.computeAcceleration(AbsoluteDate date,
PVCoordinates pv)
Compute acceleration in rotating frame
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
TopocentricFrame.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the topocentric frame origin in the selected frame. |
PVCoordinates |
TopocentricFrame.transformFromCardanToPV(CardanMountPV cardan)
Transform a Cardan mounting into Cartesian coordinates (position and velocity) expressed in this
local topocentric frame.
|
PVCoordinates |
TopocentricFrame.transformFromTopocentricToPV(TopocentricPV topoCoord)
Transform topocentric set of coordinates into Cartesian position and velocity coordinates
expressed in this local topocentric frame .
|
Modifier and Type | Method and Description |
---|---|
double |
TopocentricFrame.getAzimuthRate(PVCoordinates extPV,
Frame frame,
AbsoluteDate date)
Get the azimuth rate of a point.
|
double |
TopocentricFrame.getElevationRate(PVCoordinates extPV,
Frame frame,
AbsoluteDate date)
Get the elevation rate of a 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.
|
double |
TopocentricFrame.getXangleCardanRate(PVCoordinates extPV,
Frame frame,
AbsoluteDate date)
Get the Cardan x angle rate.
|
double |
TopocentricFrame.getYangleCardanRate(PVCoordinates extPV,
Frame frame,
AbsoluteDate date)
Get the Cardan y angle rate.
|
protected abstract Rotation |
LOFType.rotationFromInertial(PVCoordinates pv)
Get the rotation from inertial frame to local orbital frame.
|
Transform |
LOFType.transformFromInertial(AbsoluteDate date,
PVCoordinates pv)
Get the transform from an inertial frame defining position-velocity and the local orbital frame.
|
Transform |
LOFType.transformFromInertial(AbsoluteDate date,
PVCoordinates pv,
boolean computeSpinDerivatives)
Get the transform from an inertial frame defining position-velocity and the local orbital 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.
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
Transform.getCartesian()
Get the position and velocity of the "destination" frame in the "origin" one.
|
PVCoordinates |
Transform.transformPVCoordinates(PVCoordinates pv)
Transform
PVCoordinates including kinematic effects from an algebraic point of view. |
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
Transform.transformPVCoordinates(PVCoordinates pv)
Transform
PVCoordinates including kinematic effects from an algebraic point of view. |
Constructor and Description |
---|
Transform(AbsoluteDate dateIn,
PVCoordinates cartesianIn)
Build a translation transform, with its first time derivative.
|
Transform(AbsoluteDate dateIn,
PVCoordinates cartesianIn,
AngularCoordinates angularIn)
Build a transform from its primitive operations.
|
Modifier and Type | Method and Description |
---|---|
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. |
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
Orbit.getPVCoordinates()
Get the
PVCoordinates in definition 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. |
protected PVCoordinates |
EquinoctialOrbit.initPVCoordinates()
Compute the position/velocity coordinates from the canonical parameters.
|
protected PVCoordinates |
CircularOrbit.initPVCoordinates()
Compute the position/velocity coordinates from the canonical parameters.
|
protected PVCoordinates |
ApsisOrbit.initPVCoordinates()
Compute the position/velocity coordinates from the canonical parameters.
|
protected PVCoordinates |
EquatorialOrbit.initPVCoordinates()
Compute the position/velocity coordinates from the canonical parameters.
|
protected PVCoordinates |
KeplerianOrbit.initPVCoordinates()
Compute the position/velocity coordinates from the canonical parameters.
|
protected PVCoordinates |
CartesianOrbit.initPVCoordinates()
Compute the position/velocity coordinates from the canonical parameters.
|
protected abstract PVCoordinates |
Orbit.initPVCoordinates()
Compute the position/velocity coordinates from the canonical parameters.
|
Constructor and Description |
---|
ApsisOrbit(PVCoordinates pvCoordinates,
Frame frame,
AbsoluteDate date,
double mu)
Constructor from cartesian parameters.
|
CartesianOrbit(PVCoordinates pvCoordinates,
Frame frame,
AbsoluteDate date,
double mu)
Constructor from cartesian parameters.
|
CircularOrbit(PVCoordinates pvCoordinates,
Frame frame,
AbsoluteDate date,
double mu)
Constructor from cartesian parameters.
|
EquatorialOrbit(PVCoordinates pvCoordinates,
Frame frame,
AbsoluteDate date,
double mu)
Constructor from cartesian parameters.
|
EquinoctialOrbit(PVCoordinates pvCoordinates,
Frame frame,
AbsoluteDate date,
double mu)
Constructor from cartesian parameters.
|
KeplerianOrbit(PVCoordinates pvCoordinates,
Frame frame,
AbsoluteDate date,
double mu)
Constructor from cartesian parameters.
|
Orbit(PVCoordinates pvCoordinatesIn,
Frame frameIn,
AbsoluteDate dateIn,
double muIn)
Set the orbit from Cartesian parameters.
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
CartesianParameters.getPVCoordinates()
Get the PV coordinates.
|
Constructor and Description |
---|
CartesianParameters(PVCoordinates pvCoordinatesIn,
double mu)
Constructor with PV coordinates.
|
Modifier and Type | Class and Description |
---|---|
class |
TimeStampedPVCoordinates
time-stamped version of PVCoordinates . |
Modifier and Type | Field and Description |
---|---|
protected PVCoordinates[] |
AbstractBoundedPVProvider.tPVCoord
Position velocity coordinates table
|
static PVCoordinates |
PVCoordinates.ZERO
Fixed position/velocity/acceleration at origin (both p, v and a are zero vectors).
|
Modifier and Type | Method and Description |
---|---|
protected PVCoordinates |
AbstractBoundedPVProvider.checkBounds(AbsoluteDate date)
Returns PV Coordinates on bounds if duration is on bounds.
|
static PVCoordinates |
PVCoordinates.crossProduct(PVCoordinates pv1,
PVCoordinates pv2)
Compute the cross-product of two instances.
|
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 |
AlmanacPVCoordinates.getPVCoordinates(AbsoluteDate date,
Frame frame)
Geometric computation of the position to a date.
|
PVCoordinates |
PVCoordinatesProvider.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the body in the selected frame. |
PVCoordinates |
EphemerisPvHermite.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the body in the selected frame. |
PVCoordinates |
PVCoordinates.negate()
Get the opposite of the instance.
|
PVCoordinates |
PVCoordinates.normalize()
Normalize the position part of the instance.
|
PVCoordinates |
PVCoordinates.shiftedBy(double dt)
Get a time-shifted state.
|
Modifier and Type | Method and Description |
---|---|
static PVCoordinates |
PVCoordinates.crossProduct(PVCoordinates pv1,
PVCoordinates pv2)
Compute the cross-product of two instances.
|
static double[][] |
JacobianTransformationMatrix.getJacobianCartesianToSpheric(PVCoordinates pvCoordinates)
Get Jacobian for spheric coordinates transformation to cartesian
coordinates
|
static double[][] |
JacobianTransformationMatrix.getJacobianSphericToCartesian(PVCoordinates pvCoordinates)
Get Jacobian for cartesian coordinates transformation to spheric
coordinates.
|
Constructor and Description |
---|
AbstractBoundedPVProvider(PVCoordinates[] tabPV,
int order,
Frame frame,
AbsoluteDate[] tabDate,
ISearchIndex algo)
Instantiation of AbstractBoundedPVProvider attributes.
|
EphemerisPvHermite(PVCoordinates[] tabPV,
int samples,
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 number of samples = 2.
|
EphemerisPvLagrange(PVCoordinates[] tabPV,
int order,
Frame frame,
AbsoluteDate[] tabDate,
ISearchIndex algo)
Creates an instance of EphemerisPvLagrange
|
PVCoordinates(double a,
PVCoordinates pv)
Multiplicative constructor.
|
PVCoordinates(double a1,
PVCoordinates pv1,
double a2,
PVCoordinates pv2)
Linear constructor.
|
PVCoordinates(double a1,
PVCoordinates pv1,
double a2,
PVCoordinates pv2,
double a3,
PVCoordinates pv3)
Linear constructor.
|
PVCoordinates(double a1,
PVCoordinates pv1,
double a2,
PVCoordinates pv2,
double a3,
PVCoordinates pv3,
double a4,
PVCoordinates pv4)
Linear constructor.
|
PVCoordinates(PVCoordinates start,
PVCoordinates end)
Subtractive constructor.
|
TimeStampedPVCoordinates(AbsoluteDate dateIn,
double a,
PVCoordinates pv)
Multiplicative constructor
|
TimeStampedPVCoordinates(AbsoluteDate dateIn,
double a1,
PVCoordinates pv1,
double a2,
PVCoordinates pv2)
Linear constructor
|
TimeStampedPVCoordinates(AbsoluteDate dateIn,
double a1,
PVCoordinates pv1,
double a2,
PVCoordinates pv2,
double a3,
PVCoordinates pv3)
Linear constructor
|
TimeStampedPVCoordinates(AbsoluteDate dateIn,
double a1,
PVCoordinates pv1,
double a2,
PVCoordinates pv2,
double a3,
PVCoordinates pv3,
double a4,
PVCoordinates pv4)
Linear constructor
|
TimeStampedPVCoordinates(AbsoluteDate dateIn,
PVCoordinates pv)
Build from position velocity acceleration coordinates.
|
TimeStampedPVCoordinates(AbsoluteDate dateIn,
PVCoordinates start,
PVCoordinates end)
Subtractive constructor
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
SpacecraftState.getPVCoordinates()
Get the
PVCoordinates in orbit definition 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. |
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
TLESeries.getPVCoordinates(AbsoluteDate date)
Get the extrapolated position and velocity from an initial date.
|
PVCoordinates |
TLEPropagator.getPVCoordinates(AbsoluteDate date)
Get the extrapolated position and velocity from an initial TLE.
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
NumericalPropagator.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the body in the selected frame. |
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
MultiNumericalPropagator.getPVCoordinates(AbsoluteDate date,
Frame frame,
String satId)
Get the
PVCoordinates of the body in the selected frame. |
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
Ephemeris.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the body in the selected frame. |
PVCoordinates |
IntegratedEphemeris.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the body in the selected frame. |
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
MultiIntegratedEphemeris.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the body in the selected frame. |
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
MeeusMoonStela.getPVCoordinates(AbsoluteDate date,
Frame frame) |
Modifier and Type | Method and Description |
---|---|
Vector3D |
SRPSquaring.computeAcceleration(StelaEquinoctialOrbit orbit,
PVCoordinates satSunVector)
Compute the acceleration due to the force.
|
protected double[] |
SRPSquaring.computeInOutTrueAnom(StelaEquinoctialOrbit orbit,
PVCoordinates sunPV)
Computation of in and out true anomalies of the shadowed part of the orbit.
|
protected double[] |
SRPSquaring.computeSunBetaPhi(StelaEquinoctialOrbit orbit,
PVCoordinates sunPV)
Computation of Sun's right ascension (φ) and declination (β) wrt the orbit plane.
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
StelaEquinoctialOrbit.getPVCoordinates(AbsoluteDate otherDate,
Frame otherFrame) |
protected PVCoordinates |
StelaEquinoctialOrbit.initPVCoordinates() |
Constructor and Description |
---|
StelaEquinoctialOrbit(PVCoordinates pvCoordinates,
Frame frame,
AbsoluteDate date,
double mu)
Constructor from cartesian parameters.
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
StelaAbstractPropagator.getPVCoordinates(AbsoluteDate date,
Frame frame)
Get the
PVCoordinates of the body in the selected frame. |
Modifier and Type | Method and Description |
---|---|
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.
|
Modifier and Type | Method and Description |
---|---|
Map<AbsoluteDate,PVCoordinates> |
UserEphemeris.getEphemeris() |
Map<AbsoluteDate,PVCoordinates> |
IUserEphemeris.getEphemeris() |
Modifier and Type | Class and Description |
---|---|
class |
PVCoordinatesDPFacade
This class is a facade for the use of PVCoordinates.
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
BasicPVCoordinatesProvider.getPVCoordinates(AbsoluteDate date,
Frame inFrame)
Get the
PVCoordinates of the body in the selected frame. |
Modifier and Type | Method and Description |
---|---|
List<PVCoordinates> |
PVEphemerisLoader.getEphemeris()
Give the list of PV coordinates which have been read.
|
Constructor and Description |
---|
BasicPVCoordinatesProvider(PVCoordinates inCoordinates,
Frame inFrame)
Build a direction from an origin and a target described by their
PVCoordinatesProvider
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
AngularCoordinates.applyTo(PVCoordinates pv)
Apply the rotation to a pv coordinates.
|
Modifier and Type | Method and Description |
---|---|
PVCoordinates |
AngularCoordinates.applyTo(PVCoordinates pv)
Apply the rotation to a pv coordinates.
|
Constructor and Description |
---|
AngularCoordinates(PVCoordinates u1,
PVCoordinates u2,
PVCoordinates v1,
PVCoordinates v2,
double tolerance)
Build the rotation that transforms a pair of pv coordinates into another one.
|
AngularCoordinates(PVCoordinates u1,
PVCoordinates u2,
PVCoordinates v1,
PVCoordinates v2,
double tolerance,
boolean spinDerivativesComputation)
Build the rotation that transforms a pair of pv coordinates into another one.
|
TimeStampedAngularCoordinates(AbsoluteDate dateIn,
PVCoordinates u1,
PVCoordinates u2,
PVCoordinates v1,
PVCoordinates v2,
double tolerance)
Build the rotation that transforms a pair of pv coordinates into another pair.
|
TimeStampedAngularCoordinates(AbsoluteDate dateIn,
PVCoordinates u1,
PVCoordinates u2,
PVCoordinates v1,
PVCoordinates v2,
double tolerance,
boolean spinDerivativesComputation)
Build the rotation that transforms a pair of pv coordinates into another pair.
|
Copyright © 2018 CNES. All Rights Reserved.