- c1 - Variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
C1 from SPTRCK #3.
- C1AL - Static variable in class fr.cnes.sirius.patrius.forces.radiation.KnockeRiesModel
-
coefficient c1al of Knocke-Ries model.
- C1IR - Static variable in class fr.cnes.sirius.patrius.forces.radiation.KnockeRiesModel
-
coefficient c1ir of Knocke-Ries model.
- c2 - Variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
C2 from SPTRCK #3.
- c2h - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Intermediate values.
- c3h - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Intermediate values.
- c4 - Variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
C4 from SPTRCK #3.
- C_N - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
-
Default normal force coefficient parameter name.
- C_T - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
-
Default tangential force coefficient parameter name.
- C_X - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroCrossSectionProperty
-
Default drag force coefficient parameter name.
- C_X - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
-
Default drag force coefficient parameter name.
- C_Z - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
-
Default lift coefficient parameter name.
- cachedAlti - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Ellipsoid altitude in km (minimum altitude: 120 km).
- cachedDay - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Number of days in current year.
- cachedF - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Instant solar flux. f[1] = instantaneous flux; f[2] = 0.
- cachedFbar - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Mean solar flux. fbar[1] = mean flux; fbar[2] = 0.
- cachedHl - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Local solar time (rad).
- cachedTemperature - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Cache mechanism - Temperature at altitude z (K).
- CacheEntry<K,V> - Class in fr.cnes.sirius.patrius.tools.cache
-
- CacheEntry(K, V) - Constructor for class fr.cnes.sirius.patrius.tools.cache.CacheEntry
-
Standard constructor.
- cacheFreq - Variable in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAngularVelocitiesAttitudeProfile
-
Cache frequency.
- calculateAdjustedRSquared() - Method in class fr.cnes.sirius.patrius.math.stat.regression.OLSMultipleLinearRegression
-
Returns the adjusted R-squared statistic, defined by the formula
R
2adj = 1 - [SSR (n - 1)] / [SSTO (n - p)]
where SSR is the
sum of squared residuals, SSTO is the
total sum of squares, n is the number of observations and p is the number
of parameters estimated (including the intercept).
- calculateBeta() - Method in class fr.cnes.sirius.patrius.math.stat.regression.AbstractMultipleLinearRegression
-
Calculates the beta of multiple linear regression in matrix notation.
- calculateBeta() - Method in class fr.cnes.sirius.patrius.math.stat.regression.GLSMultipleLinearRegression
-
Calculates beta by GLS.
- calculateBeta() - Method in class fr.cnes.sirius.patrius.math.stat.regression.OLSMultipleLinearRegression
-
Calculates the regression coefficients using OLS.
- calculateBetaVariance() - Method in class fr.cnes.sirius.patrius.math.stat.regression.AbstractMultipleLinearRegression
-
Calculates the beta variance of multiple linear regression in matrix
notation.
- calculateBetaVariance() - Method in class fr.cnes.sirius.patrius.math.stat.regression.GLSMultipleLinearRegression
-
Calculates the variance on the beta.
- calculateBetaVariance() - Method in class fr.cnes.sirius.patrius.math.stat.regression.OLSMultipleLinearRegression
-
Calculates the variance-covariance matrix of the regression parameters.
- calculateErrorVariance() - Method in class fr.cnes.sirius.patrius.math.stat.regression.AbstractMultipleLinearRegression
-
Calculates the variance of the error term.
- calculateErrorVariance() - Method in class fr.cnes.sirius.patrius.math.stat.regression.GLSMultipleLinearRegression
-
Calculates the estimated variance of the error term using the formula
Var(u) = Tr(u' Omega^-1 u)/(n-k)
where n and k are the row and column dimensions of the design
matrix X.
- calculateField(double, double, double) - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Calculate the magnetic field at the specified latitude, longitude and height.
- calculateField(EllipsoidPoint) - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Calculate the magnetic field at the specified ellipsoid point identified by latitude, longitude and height.
- calculateField(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Calculate the magnetic field at the specified point identified by the coordinates of the point and the reference
point.
- calculateHat() - Method in class fr.cnes.sirius.patrius.math.stat.regression.OLSMultipleLinearRegression
-
Compute the "hat" matrix.
- calculateNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
- calculateNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.ZipfDistribution
-
- calculateNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.FDistribution
-
- calculateNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.HypergeometricDistribution
-
- calculateNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
- calculateNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.ZipfDistribution
-
- calculatePathDelay(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.SaastamoinenModel
-
Calculates the tropospheric path delay for the signal path from a ground station to a
satellite at a given date.
- calculatePhase1InitialFeasiblePoint(double[], double) - Method in interface fr.cnes.sirius.patrius.math.optim.joptimizer.functions.BarrierFunction
-
Calculates the initial value for the additional variable s in basic Phase I method.
- calculatePhase1InitialFeasiblePoint(double[], double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.functions.LogarithmicBarrier
-
Calculates the initial value for the s parameter in Phase I.
- calculateResiduals() - Method in class fr.cnes.sirius.patrius.math.stat.regression.AbstractMultipleLinearRegression
-
Calculates the residuals of multiple linear regression in matrix
notation.
- calculateResidualSumOfSquares() - Method in class fr.cnes.sirius.patrius.math.stat.regression.OLSMultipleLinearRegression
-
Returns the sum of squared residuals.
- calculateRSquared() - Method in class fr.cnes.sirius.patrius.math.stat.regression.OLSMultipleLinearRegression
-
- calculateScaledResidual(RealMatrix, RealMatrix, RealMatrix) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.util.Utils
-
Calculate the scaled residual
||Ax-b||_oo/( ||A||_oo .
- calculateScaledResidual(RealMatrix, RealVector, RealVector) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.util.Utils
-
Calculate the scaled residual
||Ax-b||_oo/( ||A||_oo .
- calculateTotalSumOfSquares() - Method in class fr.cnes.sirius.patrius.math.stat.regression.OLSMultipleLinearRegression
-
Returns the sum of squared deviations of Y from its mean.
- calculateYVariance() - Method in class fr.cnes.sirius.patrius.math.stat.regression.AbstractMultipleLinearRegression
-
Calculates the variance of the y values.
- call() - Method in class fr.cnes.sirius.patrius.tools.parallel.AbstractSimpleParallelTaskImpl
-
- call() - Method in interface fr.cnes.sirius.patrius.tools.parallel.ParallelTask
-
- callImpl() - Method in class fr.cnes.sirius.patrius.tools.parallel.AbstractSimpleParallelTaskImpl
-
Call implementation to be provided by the implementing class.
- cancelStepAccepted() - Method in class fr.cnes.sirius.patrius.events.utils.EventState
-
Cancel stepAccepted call (does not cancel event).
- cancelStepAccepted() - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Cancel stepAccepted call (does not cancel event).
- canIncrement() - Method in class fr.cnes.sirius.patrius.math.util.Incrementor
-
Checks whether a single increment is allowed.
- canMap(EllipsoidPoint) - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
-
Returns a boolean depending if the ellipsoid point can be map with the selected projection method.
- canMap(EllipsoidPoint) - Method in interface fr.cnes.sirius.patrius.projections.IProjection
-
Returns a boolean depending if the ellipsoid point can be map with the selected projection method.
- canMap(EllipsoidPoint) - Method in class fr.cnes.sirius.patrius.projections.Mercator
-
Returns a boolean depending if the ellipsoid point can be map with the selected projection method.
- CardanCalculator - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
Compute X and Y Cardan angles of a point, defined by its Cartesian coordinates in a frame whose Y, Z axis, local
vertical and west
directions axis are in the same Plane.
- CardanMountPosition - Class in fr.cnes.sirius.patrius.orbits.pvcoordinates
-
- CardanMountPosition(double, double, double) - Constructor for class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPosition
-
Build Cardan mount.
- CardanMountPV - Class in fr.cnes.sirius.patrius.orbits.pvcoordinates
-
- CardanMountPV(double, double, double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Build cardan mounting.
- CARRIER_RETURN - Static variable in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Carrier return ('\n').
- CartesianCoordinate - Enum in fr.cnes.sirius.patrius.orbits.orbitalparameters
-
Enumerates the different coordinates associated with the cartesian parameters.
- CartesianDerivativesFilter - Enum in fr.cnes.sirius.patrius.utils
-
- CartesianGridAttractionLoader - Class in fr.cnes.sirius.patrius.forces.gravity.grid
-
Grid attraction model loader.
- CartesianGridAttractionLoader(String) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.grid.CartesianGridAttractionLoader
-
Constructor.
- CartesianOrbit - Class in fr.cnes.sirius.patrius.orbits
-
This class holds cartesian orbital parameters.
- CartesianOrbit(IOrbitalParameters, Frame, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Creates a new instance.
- CartesianOrbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Constructor from cartesian parameters.
- CartesianOrbit(Orbit) - Constructor for class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Constructor from any kind of orbital parameters.
- CartesianParameters - Class in fr.cnes.sirius.patrius.orbits.orbitalparameters
-
This class holds cartesian orbital parameters.
- CartesianParameters(PVCoordinates, double) - Constructor for class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Constructor with PV coordinates.
- CartesianParameters(Vector3D, Vector3D, Vector3D, double) - Constructor for class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Constructor with position and velocity.
- castOrTransform(SymmetricPositiveMatrix) - Static method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
- CauchyDistribution - Class in fr.cnes.sirius.patrius.math.distribution
-
Implementation of the Cauchy distribution.
- CauchyDistribution() - Constructor for class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Creates a Cauchy distribution with the median equal to zero and scale
equal to one.
- CauchyDistribution(double, double) - Constructor for class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Creates a Cauchy distribution using the given median and scale.
- CauchyDistribution(double, double, double) - Constructor for class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Creates a Cauchy distribution using the given median and scale.
- CauchyDistribution(RandomGenerator, double, double, double) - Constructor for class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Creates a Cauchy distribution.
- cbrt() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Cubic root.
- Cbrt - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Cube root function.
- Cbrt() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Cbrt
-
- cbrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Compute the cubic root of a number.
- cbrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Compute the cubic root of a number.
- cbrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Compute the cubic root of a number.
- cbrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Compute the cubic root of a number.
- cbrt(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Compute the cubic root of a number.
- cbrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Compute the cubic root of a number.
- cbrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Compute the cubic root of a number.
- cbrt() - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Cubic root.
- cbrt(double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Compute the cubic root of a number.
- cbrt(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Compute the cubic root of a number.
- cc - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Number of particles per cm3. cc(1) = hydrogen cc(2) = helium cc(3) = atomic oxygen cc(4) = molecular nitrogen
cc(5) = molecular oxygen cc(6) = atomic nitrogen
- ccor(double, double, double, double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.NRLMSISE00
-
ccor.
- ccor2(double, double, double, double, double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.NRLMSISE00
-
ccor2.
- CCSDS_EPOCH - Static variable in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Reference epoch for CCSDS Time Code Format (CCSDS 301.0-B-4):
1958-01-01T00:00:00 International Atomic Time (not UTC).
- CCSDS_EPOCH - Static variable in class fr.cnes.sirius.patrius.time.DateComponents
-
Reference epoch for CCSDS Time Code Format (CCSDS 301.0-B-4): 1958-01-01.
- cdf(double) - Method in class fr.cnes.sirius.patrius.math.distribution.KolmogorovSmirnovDistribution
-
Calculates P(D_n < d) using method described in [1] with quick
decisions for extreme values given in [2] (see above).
- cdf(double, boolean) - Method in class fr.cnes.sirius.patrius.math.distribution.KolmogorovSmirnovDistribution
-
Calculates P(D_n < d) using method described in [1] with quick
decisions for extreme values given in [2] (see above).
- cdfExact(double) - Method in class fr.cnes.sirius.patrius.math.distribution.KolmogorovSmirnovDistribution
-
Calculates P(D_n < d) using method described in [1] with quick
decisions for extreme values given in [2] (see above).
- ceil() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Get the smallest whole number larger than instance.
- Ceil - Class in fr.cnes.sirius.patrius.math.analysis.function
-
ceil function.
- Ceil() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Ceil
-
- ceil() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Round to an integer using the round ceil mode.
- ceil(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Get the smallest whole number larger than x.
- ceil(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Get the smallest whole number larger than x.
- ceil(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Get the smallest whole number larger than x.
- ceil(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Get the smallest whole number larger than x.
- ceil(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Get the smallest whole number larger than x.
- ceil(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Get the smallest whole number larger than x.
- ceil(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Get the smallest whole number larger than x.
- ceil() - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Get the smallest whole number larger than instance.
- ceil(double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Get the smallest whole number larger than x.
- ceil(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Get the smallest whole number larger than x.
- celestialBodiesMaskingDistance(AbsoluteDate, AbsoluteDate, AbstractSignalPropagationDetector.PropagationDelayType, VisibilityFromStationDetector.LinkType) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the minimal euclidian distance to the celestial body shapes.
- CelestialBody - Interface in fr.cnes.sirius.patrius.bodies
-
Interface for celestial bodies like Sun, Moon or solar system planets.
- CelestialBodyEphemeris - Interface in fr.cnes.sirius.patrius.bodies
-
Interface for celestial body ephemeris.
- CelestialBodyEphemerisLoader - Interface in fr.cnes.sirius.patrius.bodies
-
Interface for loading celestial bodies ephemeris.
- CelestialBodyFactory - Class in fr.cnes.sirius.patrius.bodies
-
Factory class for bodies of the solar system.
- CelestialBodyFrame - Class in fr.cnes.sirius.patrius.frames
-
- CelestialBodyFrame(String, boolean) - Constructor for class fr.cnes.sirius.patrius.frames.CelestialBodyFrame
-
Protected constructor used only for the root frame.
- CelestialBodyFrame(Frame, Transform, String, CelestialPoint) - Constructor for class fr.cnes.sirius.patrius.frames.CelestialBodyFrame
-
Constructor.
- CelestialBodyFrame(Frame, TransformProvider, String, CelestialPoint) - Constructor for class fr.cnes.sirius.patrius.frames.CelestialBodyFrame
-
Constructor.
- CelestialBodyFrame(Frame, Transform, String, boolean, CelestialPoint) - Constructor for class fr.cnes.sirius.patrius.frames.CelestialBodyFrame
-
Constructor.
- CelestialBodyFrame(Frame, TransformProvider, String, boolean, CelestialPoint) - Constructor for class fr.cnes.sirius.patrius.frames.CelestialBodyFrame
-
Generic constructor.
- CelestialBodyIAUOrientation - Interface in fr.cnes.sirius.patrius.bodies
-
Interface for IAU pole and primer meridian orientations.
- CelestialBodyLoader - Interface in fr.cnes.sirius.patrius.bodies
-
Interface for loading celestial bodies/points.
- CelestialBodyOrientation - Interface in fr.cnes.sirius.patrius.bodies
-
Interface to represent a celestial body orientation.
- CelestialBodyOrientation.OrientationType - Enum in fr.cnes.sirius.patrius.bodies
-
Describe the orientation type.
- CelestialBodyPointed - Class in fr.cnes.sirius.patrius.attitudes
-
This class handles a celestial body pointed attitude provider.
- CelestialBodyPointed(Frame, PVCoordinatesProvider, Vector3D, Vector3D, Vector3D) - Constructor for class fr.cnes.sirius.patrius.attitudes.CelestialBodyPointed
-
Creates new instance.
- CelestialBodyPolesAxisDirection - Class in fr.cnes.sirius.patrius.attitudes.directions
-
This direction is the axis defined by the two poles of a
celestial body.
- CelestialBodyPolesAxisDirection(CelestialBody) - Constructor for class fr.cnes.sirius.patrius.attitudes.directions.CelestialBodyPolesAxisDirection
-
Build a direction defined by the frame associated to a celestial body.
- CelestialBodyTabulatedOrientation - Class in fr.cnes.sirius.patrius.bodies
-
Celestial body orientation represented by a tabulated attitude leg (quaternions).
- CelestialBodyTabulatedOrientation(TabulatedAttitude) - Constructor for class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Constructor.
- CelestialPoint - Interface in fr.cnes.sirius.patrius.bodies
-
Interface for celestial points like Sun, Moon or solar system planets (without modeling the shape, orientation, etc).
- celestialPoint - Variable in class fr.cnes.sirius.patrius.frames.CelestialBodyFrame
-
Celestial point centered on this frame.
- CelestialPoint.BodyNature - Enum in fr.cnes.sirius.patrius.bodies
-
Body nature.
- CenteredAolPassageDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Centered argument of latitude detector
- CenteredAolPassageDetector(double, PositionAngle, MeanOsculatingElementsProvider, Frame) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CenteredAolPassageDetector
-
Constructor
- CenteredAolPassageDetector(double, PositionAngle, MeanOsculatingElementsProvider, Frame, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CenteredAolPassageDetector
-
Constructor with complementary parameters
- CenteredAolPassageDetector(double, PositionAngle, MeanOsculatingElementsProvider, Frame, double, double, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CenteredAolPassageDetector
-
Constructor with complementary parameters
- centeredToOsculating(CircularOrbit) - Method in class fr.cnes.sirius.patrius.events.detectors.CenteredAolPassageDetector
-
- CentralBodyMaskCircularFOVDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Finder for target entry/exit events with respect to a satellite sensor FOV defined by a vector3D
giving the direction in satellite frame and taking into account masking from the central body
This class handles fields of view with a circular boundary.
- CentralBodyMaskCircularFOVDetector(PVCoordinatesProvider, double, BodyShape, boolean, Vector3D, double, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CentralBodyMaskCircularFOVDetector
-
Constructor with user maxcheck and threshold creating a circularFOVDetector and an
EllipsoidEclipseDetector
The default implementation behaviour is to
stop propagation when the target is
visible.
- CentralBodyMaskCircularFOVDetector(PVCoordinatesProvider, double, BodyShape, boolean, Vector3D, double, double, double, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CentralBodyMaskCircularFOVDetector
-
Constructor with user maxcheck and threshold creating a circularFOVDetector and an
EllipsoidEclipseDetector
- CentralBodyMaskCircularFOVDetector(PVCoordinatesProvider, double, BodyShape, boolean, Vector3D, double, double, double, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CentralBodyMaskCircularFOVDetector
-
Constructor with user maxcheck and threshold creating a circularFOVDetector and an
EllipsoidEclipseDetector
- CentralBodyMaskCircularFOVDetector(EclipseDetector, CircularFieldOfViewDetector, double, double, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CentralBodyMaskCircularFOVDetector
-
Constructor with EclipseDetector and CircularFieldOfViewDetector.
- CentralBodyMaskCircularFOVDetector(PVCoordinatesProvider, double, BodyShape, boolean, Vector3D, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CentralBodyMaskCircularFOVDetector
-
Constructor with default maxcheck and default threshold, creating a circularFOVDetector and
an EllipsoidEclipseDetector
- centroidOf(Collection<T>) - Method in interface fr.cnes.sirius.patrius.math.stat.clustering.Clusterable
-
Returns the centroid of the given Collection of points.
- centroidOf(Collection<EuclideanDoublePoint>) - Method in class fr.cnes.sirius.patrius.math.stat.clustering.EuclideanDoublePoint
-
Returns the centroid of the given Collection of points.
- centroidOf(Collection<EuclideanIntegerPoint>) - Method in class fr.cnes.sirius.patrius.math.stat.clustering.EuclideanIntegerPoint
-
Returns the centroid of the given Collection of points.
- CGU - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
OBELIX gravitational constant.
- ch - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Intermediate values.
- ChebyshevDecompositionEngine - Class in fr.cnes.sirius.patrius.math.analysis.polynomials
-
- checkAbsoluteThreshold(Double) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Ensures the provided absolute threshold is either null or a positive number (zero
included).
- checkAdditionCompatible(FieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Check if a matrix is addition compatible with the instance.
- checkAdditionCompatible(AnyMatrix, AnyMatrix) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Check if matrices are addition compatible.
- checkAndUpdate(CounterArray) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.CounterArray
-
Check and update, if needed, counter array.
- checkApKpValidity(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Check that solar data (ap/kp) are available in the user range [start; end].
- checkApSanity(double) - Static method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityToolbox
-
Check that the specified ap coefficient is within bounds
- checkArrayIndex(double[][], int, int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if the provided indices are valid row and column indices for a given 2D-array.
- checkBinomial(int, int) - Static method in class fr.cnes.sirius.patrius.math.util.CombinatoricsUtils
-
Check binomial preconditions.
- checkBounds(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractBoundedPVProvider
-
Returns PV Coordinates on bounds if duration is on bounds.
- checkColumnDimension(int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks the validity of the provided column dimension (must be strictly positive).
- checkColumnIndex(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Check if a column index is valid.
- checkColumnIndex(AnyMatrix, int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if an index is a valid column index for a given matrix.
- checkColumnIndices(AnyMatrix, int[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if the provided indices are valid column indices for a given matrix.
- checkCompatibility(DSCompiler) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Check rules set compatibility.
- checkContractExpand(double, double) - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Checks the expansion factor and the contraction criterion and raises
an exception if the contraction criterion is smaller than the
expansion criterion.
- checkCovarianceMatrixDimension() - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Checks the covariance matrix and throws an exception if its dimensions are not large enough
to store the orbital parameters of a single orbit.
- checkCovarianceMatrixDimension(int) - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Checks the covariance matrix and throws an exception if its dimensions are not large enough
to store the orbital parameters of a given number of orbits.
- checkCustomExitConditions(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Overriding this, a subclass can define some extra condition for exiting the iteration loop.
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.drag.DragForce
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.ForceModel
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.DirectBodyAttraction
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.ThirdBodyAttraction
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTides
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.PoleTides
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.TerrestrialTides
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.relativistic.CoriolisRelativisticEffect
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.relativistic.LenseThirringRelativisticEffect
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.relativistic.SchwarzschildRelativisticEffect
-
This methods throws an exception if the user did not provide all the required data to perform model call on
provided range [start; end].
- checkDataArray(double[]) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Checks the validity of the provided data array.
- checkDataArray(double[]) - Static method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Checks the validity of the provided data array.
- checkDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAttitudeProfile
-
Check date validity.
- checkDestinationArray(int, int, double[][], int, int) - Static method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Ensures the destination array is not null, and large enough to store the data of a
submatrix.
- checkDimension(int, int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Check if the provided dimension is the one expected.
- checkDuplicates(int[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if the provided array contains duplicates.
- checkEOPContinuity(double) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Check Earth orientation parameters continuity.
- checkFinite(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Check that the argument is a real number.
- checkFinite(double[]) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Check that all the elements are real numbers.
- checkFluxValidity(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Check that solar data (flux) are available in the user range [start; end].
- checkHandleAccess(int, String) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandle
-
Signal an error if a DAF file handle does not designate a DAF that is open for a specified type of access.
- checkIndex(int) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Check if an index is valid.
- checkIndices(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Checks that the indices of a subvector are valid.
- checkKKTSolutionAcc - Variable in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Check if the KTT accuracy is preserved
- checkKKTSolutionAccuracy(RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Check the solution of the system
KKT.x = b
against the scaled residual
beta < gamma,
where gamma is a parameter chosen by the user and beta is
the scaled residual,
beta = ||KKT.x-b||_oo/( ||KKT||_oo .
- checkKKTSolutionAccuracy(RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.UpperDiagonalHKKTSolver
-
Check the solution of the system
KKT.x = b
against the scaled residual
beta < gamma,
where gamma is a parameter chosen by the user and beta is
the scaled residual,
beta = ||KKT.x-b||_oo/( ||KKT||_oo .
- checkKpSanity(double) - Static method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityToolbox
-
Check that the specified kp coefficient is within bounds
- checkMatrix(RealMatrix) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Ensures the provided matrix is not null and is a square matrix.
- checkMatrixArray(double[][]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks the validity of a matrix data array.
- checkMatrixArray(double[][], boolean) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks the validity of a matrix data array.
- checkMatrixArray(Object[][]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks the validity of a matrix data array.
- checkMatrixArray(Object[][], boolean) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks the validity of a matrix data array.
- checkMatrixIndex(AnyMatrix, int, int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if the provided indices are valid row and column indices are for a given matrix.
- checkMultiplicationCompatible(FieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Check if a matrix is multiplication compatible with the instance.
- checkMultiplicationCompatible(AnyMatrix, AnyMatrix) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Check if matrices are multiplication compatible
- checkMultiplicationCompatible(AnyMatrix, AnyMatrix, boolean) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Check if matrices are multiplication compatible
- checkNonNegative(long[]) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Check that all entries of the input array are >= 0.
- checkNonNegative(long[][]) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Check all entries of the input array are >= 0.
- checkNotNull(Object, Localizable, Object...) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Checks that an object is not null.
- checkNotNull(Object) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Checks that an object is not null.
- checkOrbit(Orbit) - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Checks an orbit and throws an exception if it is null, or if it is not defined at the
same date as this orbital covariance.
- checkOrder(double[], MathArrays.OrderDirection, boolean, boolean) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Check that the given array is sorted.
- checkOrder(double[], MathArrays.OrderDirection, boolean) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Check that the given array is sorted.
- checkOrder(double[]) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Check that the given array is sorted in strictly increasing order.
- checkParameterDescriptors() - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
- checkParameterDescriptors(int, OrbitType) - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Starting from the specified index, checks that the first six parameter descriptors associated
with the covariance have an
orbital
coordinate descriptor which is mapped to an
OrbitalCoordinate instance with the
expected state vector index.
- checkParameters(RealLinearOperator, RealVector, RealVector) - Static method in class fr.cnes.sirius.patrius.math.linear.IterativeLinearSolver
-
Performs all dimension checks on the parameters of
solve and
solveInPlace,
and throws an exception if one of the checks fails.
- checkParameters(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Static method in class fr.cnes.sirius.patrius.math.linear.PreconditionedIterativeLinearSolver
-
Performs all dimension checks on the parameters of
solve and
solveInPlace,
and throws an exception if one of the checks fails.
- checkPoint(double, double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Interval
-
Check a point with respect to the interval.
- checkPoint(Vector<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region.
- checkPoint(BSPTree<S>, Vector<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region starting at a given node.
- checkPoint(Vector<S>) - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Region
-
Check a point with respect to the region.
- checkPolygonSet() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
Method to check PolygonSet based on three criteria (three checks) :
Classification of polygons must not be CROSSING_BORDERS or DEGENERATED
Size of polygon must be different from Double.POSITIVE_INFINITY (open-loop polygon)
Remarks :
If both criteria are satisfied, polygon will have at least three points
If constructor
PolygonsSet(Vector2D[][]) is used, second exception cannot be reached
(vertices are automatically sorted in TRIGO sense, which prevent crossing borders)
If constructor
PolygonsSet(Vector2D[][]) is used, third exception cannot be reached (the
first will be reached before)
- checkPoolStateCounter(CounterArray) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.PoolSpice
-
Check and update the POOL state counter tracked by a caller (user) routine.
- checkPositive(double[]) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Check that all entries of the input array are strictly positive.
- checkPositiveSemiDefinite(SymmetricMatrix, double) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Ensures a symmetric matrix is positive semi-definite and throws an exception if that's not
the case.
- checkRectangular(long[][]) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Throws DimensionMismatchException if the input array is not rectangular.
- checkRectangularShape(RealMatrix[][]) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.AlgebraUtils
-
Checks whether the given array is rectangular, that is, whether all rows
have the same number of columns.
- checkRelativeThreshold(Double) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Ensures the provided relative threshold is either null or a positive number (zero
included).
- checkRowDimension(int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks the validity of the provided row dimension (must be strictly positive).
- checkRowIndex(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Check if a row index is valid.
- checkRowIndex(AnyMatrix, int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if an index is a valid row index for a given matrix.
- checkRowIndices(AnyMatrix, int[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if the provided indices are valid row indices for a given matrix.
- checkScaling(RealMatrix, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.Matrix1NornRescaler
-
Check if the scaling algorithm returned proper results.
- checkScaling(RealMatrix, RealVector, RealVector) - Method in interface fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.MatrixRescaler
-
Check if the scaling algorithm returned proper results.
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.Atmosphere
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.DTMInputParameters
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.HarrisPriester
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.JB2006
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000InputParameters
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.DTMSolarData
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.US76
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSolarActivityData(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
This methods throws an exception if the user did not provide solar activity on the provided interval [start,
end].
- checkSquare() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Checks if this is a square matrix and throws an exception if that's not the case.
- checkStateVectorIndex(int) - Static method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.OrbitalCoordinate
-
Static method to check if the state vector index is valid (between 0 and 5 (included)).
- checkSubMatrixIndex(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Check if submatrix ranges indices are valid.
- checkSubMatrixIndex(int[], int[]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Check if submatrix ranges indices are valid.
- checkSubMatrixIndex(AnyMatrix, int, int, int, int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if the provided sub-matrix ranges are valid for a given matrix.
- checkSubMatrixIndex(AnyMatrix, int[], int[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if the provided sub-matrix indices are valid for a given matrix.
- checkSubtractionCompatible(FieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Check if a matrix is subtraction compatible with the instance.
- checkSubtractionCompatible(AnyMatrix, AnyMatrix) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Check if matrices are subtraction compatible
- checkSymmetric(RealMatrix, double) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks whether a matrix is symmetric.
- checkSymmetry(RealMatrix, double, double) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Checks if the matrix is symmetric and throws an exception if that's not the case.
- checkUpdates(String) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.PoolSpice
-
Indicate whether or not any watched kernel variables that have a specified agent on their notification list have
been updated.
- checkUpdatesIfCounterUpdate(CounterArray, String) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.PoolSpice
-
Determine whether or not any of the POOL variables that are to be watched and have AGENT on their distribution
list have been updated, but do the full watcher check only if the POOL state counter has changed.
- checkValidity(List<T>) - Method in class fr.cnes.sirius.patrius.math.genetics.AbstractListChromosome
-
Asserts that representation can represent a valid chromosome.
- checkValidity(List<Integer>) - Method in class fr.cnes.sirius.patrius.math.genetics.BinaryChromosome
-
Asserts that representation can represent a valid chromosome.
- checkValidity(List<Double>) - Method in class fr.cnes.sirius.patrius.math.genetics.RandomKey
-
Asserts that representation can represent a valid chromosome.
- checkVectorDimensions(FieldVector<T>) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(int) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Check if instance dimension is equal to some expected value.
- chiSquare(double[], long[]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
- chiSquare(long[][]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
- chiSquare(double[], long[]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- chiSquare(long[][]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- chiSquareDataSetsComparison(long[], long[]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
- chiSquareDataSetsComparison(long[], long[]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- ChiSquaredDistribution - Class in fr.cnes.sirius.patrius.math.distribution
-
Implementation of the chi-squared distribution.
- ChiSquaredDistribution(double) - Constructor for class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
Create a Chi-Squared distribution with the given degrees of freedom.
- ChiSquaredDistribution(double, double) - Constructor for class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
Create a Chi-Squared distribution with the given degrees of freedom and
inverse cumulative probability accuracy.
- ChiSquaredDistribution(RandomGenerator, double, double) - Constructor for class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
Create a Chi-Squared distribution with the given degrees of freedom and
inverse cumulative probability accuracy.
- ChiSquareTest - Class in fr.cnes.sirius.patrius.math.stat.inference
-
Implements Chi-Square test statistics.
- ChiSquareTest() - Constructor for class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
- chiSquareTest(double[], long[]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
- chiSquareTest(double[], long[], double) - Method in class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
Performs a
Chi-square goodness of fit test evaluating the null hypothesis that the
observed counts conform to the frequency distribution described by the expected
counts, with significance level
alpha.
- chiSquareTest(long[][]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
- chiSquareTest(long[][], double) - Method in class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
Performs a
chi-square test of independence evaluating the null hypothesis that the
classifications represented by the counts in the columns of the input 2-way table
are independent of the rows, with significance level
alpha.
- chiSquareTest(double[], long[], double) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- chiSquareTest(double[], long[]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- chiSquareTest(long[][], double) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- chiSquareTest(long[][]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- chiSquareTestDataSetsComparison(long[], long[]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
Returns the
observed significance level, or
p-value, associated with a Chi-Square two
sample test comparing bin frequency counts in
observed1 and
observed2.
- chiSquareTestDataSetsComparison(long[], long[], double) - Method in class fr.cnes.sirius.patrius.math.stat.inference.ChiSquareTest
-
Performs a Chi-Square two sample test comparing two binned data sets.
- chiSquareTestDataSetsComparison(long[], long[]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- chiSquareTestDataSetsComparison(long[], long[], double) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- CholeskyDecomposition - Class in fr.cnes.sirius.patrius.math.linear
-
Calculates the Cholesky decomposition of a matrix.
- CholeskyDecomposition(RealMatrix) - Constructor for class fr.cnes.sirius.patrius.math.linear.CholeskyDecomposition
-
- CholeskyDecomposition(RealMatrix, double, double) - Constructor for class fr.cnes.sirius.patrius.math.linear.CholeskyDecomposition
-
Constructor used to set the relative & absolute thresholds.
- CholeskyFactorization - Class in fr.cnes.sirius.patrius.math.optim.joptimizer.algebra
-
Cholesky L.L[T] factorization and inverse for symmetric and positive matrix:
Q = L.L[T], L lower-triangular
Just the subdiagonal elements of Q are used.
- CholeskyFactorization(RealMatrix) - Constructor for class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.CholeskyFactorization
-
Constructor defining matrix Q, and null rescaler (to avoid rescaling)
- CholeskyFactorization(RealMatrix, MatrixRescaler) - Constructor for class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.CholeskyFactorization
-
Constructor defining matrix Q and rescaler
- Chromosome - Class in fr.cnes.sirius.patrius.math.genetics
-
Individual in a population.
- Chromosome() - Constructor for class fr.cnes.sirius.patrius.math.genetics.Chromosome
-
- ChromosomePair - Class in fr.cnes.sirius.patrius.math.genetics
-
- ChromosomePair(Chromosome, Chromosome) - Constructor for class fr.cnes.sirius.patrius.math.genetics.ChromosomePair
-
Create a chromosome pair.
- ChronologicalComparator - Class in fr.cnes.sirius.patrius.time
-
- ChronologicalComparator() - Constructor for class fr.cnes.sirius.patrius.time.ChronologicalComparator
-
- CIPCoordinates - Class in fr.cnes.sirius.patrius.frames.configuration.precessionnutation
-
This class represents a Celestial Intermediate Pole.
- CIPCoordinates(AbsoluteDate, double, double, double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Constructor for the CIP pole coordinates.
- CIPCoordinates(AbsoluteDate, double[], double[]) - Constructor for class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Constructor for the CIP pole coordinates.
- CIPCoordinatesGenerator - Class in fr.cnes.sirius.patrius.frames.configuration.precessionnutation
-
- CIPCoordinatesGenerator(PrecessionNutationModel, int, double) - Constructor for class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinatesGenerator
-
Constructor.
- CircularCoordinate - Enum in fr.cnes.sirius.patrius.orbits.orbitalparameters
-
Enumerates the different types of coordinate associated with the circular parameters.
- CircularField - Class in fr.cnes.sirius.patrius.fieldsofview
-
This class describes a right circular field of view to be used in "instruments" part properties.
- CircularField(String, double, Vector3D) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.CircularField
-
Constructor for a circular field of view.
- CircularFieldOfViewDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Finder for target entry/exit events with respect to a satellite sensor field of view.
- CircularFieldOfViewDetector(PVCoordinatesProvider, Vector3D, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CircularFieldOfViewDetector
-
Build a new instance.
- CircularFieldOfViewDetector(PVCoordinatesProvider, Vector3D, double, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CircularFieldOfViewDetector
-
Build a new instance.
- CircularFieldOfViewDetector(PVCoordinatesProvider, Vector3D, double, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CircularFieldOfViewDetector
-
Build a new instance with defined actions at fov entry and exit.
- CircularFieldOfViewDetector(PVCoordinatesProvider, Vector3D, double, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CircularFieldOfViewDetector
-
Build a new instance with defined actions at fov entry and exit.
- CircularOrbit - Class in fr.cnes.sirius.patrius.orbits
-
This class handles circular orbital parameters.
- CircularOrbit(IOrbitalParameters, Frame, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Creates a new instance.
- CircularOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double) - Constructor for class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Creates a new instance.
- CircularOrbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Constructor from cartesian parameters.
- CircularOrbit(Orbit) - Constructor for class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Constructor from any kind of orbital parameters.
- CircularParameters - Class in fr.cnes.sirius.patrius.orbits.orbitalparameters
-
This class handles circular orbital parameters.
- CircularParameters(double, double, double, double, double, double, PositionAngle, double) - Constructor for class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Creates a new instance.
- CIRFProvider - Class in fr.cnes.sirius.patrius.frames.transformations
-
Celestial Intermediate Reference Frame 2000.
- CIRFProvider() - Constructor for class fr.cnes.sirius.patrius.frames.transformations.CIRFProvider
-
- CK - Static variable in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceFrame
-
CK frame type.
- CK2 - Static variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEConstants
-
Potential perturbation coefficient.
- CK4 - Static variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEConstants
-
Potential perturbation coefficient.
- classes() - Method in class fr.cnes.sirius.patrius.math.util.TransformerMap
-
Returns the Set of Classes used as keys in the map.
- ClassicalMSISE2000SolarData - Class in fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized
-
This class represents a solar data container adapted for the
MSISE2000 atmosphere model
This model of input parameters computes averages for SOME of the ap values required by the MSISE2000 model.
- ClassicalMSISE2000SolarData(SolarActivityDataProvider) - Constructor for class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.ClassicalMSISE2000SolarData
-
Constructor.
- ClassicalRungeKuttaIntegrator - Class in fr.cnes.sirius.patrius.math.ode.nonstiff
-
This class implements the classical 4th order Runge-Kutta integrator for Ordinary Differential Equations (it is the
most often used Runge-Kutta method).
- ClassicalRungeKuttaIntegrator(double) - Constructor for class fr.cnes.sirius.patrius.math.ode.nonstiff.ClassicalRungeKuttaIntegrator
-
Simple constructor.
- classify() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Returns the type - one of FINITE, INFINITE, SNAN, QNAN.
- ClasspathCrawler - Class in fr.cnes.sirius.patrius.data
-
Provider for data files stored as resources in the classpath.
- ClasspathCrawler(String...) - Constructor for class fr.cnes.sirius.patrius.data.ClasspathCrawler
-
Build a data classpath crawler.
- ClasspathCrawler(ClassLoader, String...) - Constructor for class fr.cnes.sirius.patrius.data.ClasspathCrawler
-
Build a data classpath crawler.
- clear() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Clear the frames tree.
- clear() - Method in class fr.cnes.sirius.patrius.math.optim.BaseMultiStartMultivariateOptimizer
-
Method that will called in order to clear all stored optima.
- clear() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
-
Method that will called in order to clear all stored optima.
- clear() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.MultiStartMultivariateVectorOptimizer
-
Method that will called in order to clear all stored optima.
- clear() - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Removes all the fields currently associated with this parameter descriptor.
- clear() - Method in class fr.cnes.sirius.patrius.math.random.AbstractRandomGenerator
-
- clear() - Method in class fr.cnes.sirius.patrius.math.random.BitsStreamGenerator
-
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Resets all statistics and storage
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Kurtosis
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Mean
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SecondMoment
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Skewness
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Variance
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.VectorialCovariance
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Resets all statistics and storage
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Max
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Min
-
Clears the internal state of the Statistic
- clear() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StorelessUnivariateStatistic
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Product
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Sum
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfLogs
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfSquares
-
Clears the internal state of the Statistic
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Resets all statistics and storage
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Resets all statistics and storage
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Resets all statistics and storage
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Resets all statistics and storage
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Clears the frequency table
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.regression.MillerUpdatingRegression
-
As the name suggests, clear wipes the internals and reorders everything in the
canonical order.
- clear() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Clears all data from the model.
- clear() - Method in interface fr.cnes.sirius.patrius.math.stat.regression.UpdatingMultipleLinearRegression
-
Clears internal buffers and resets the regression model.
- clear() - Method in interface fr.cnes.sirius.patrius.math.util.DoubleArray
-
Clear the double array
- clear() - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Clear the array contents, resetting the number of elements to zero.
- clear() - Method in class fr.cnes.sirius.patrius.math.util.TransformerMap
-
Clears all the Class to Transformer mappings.
- clear() - Method in class fr.cnes.sirius.patrius.tools.cache.FIFOThreadSafeCache
-
Clears the cache.
- clear() - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
- clear() - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Clear the title and the table (the header remains).
- clearAllKernels() - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceKernelManager
-
Clear the SpiceKernelManager subsystem: unload all kernels, clear the kernel pool, and re-initialize the
subsystem.
- clearCache() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAngularVelocitiesAttitudeProfile
-
Removes all of the elements from the orientation rotation cache
- clearCelestialBodyLoaders(String) - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Clear loaders for one celestial body/point.
- clearCelestialBodyLoaders() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Clear loaders for all celestial bodies/points.
- clearConfiguration() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Clear frames configuration.
- clearEOP1980HistoryLoaders() - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Clear loaders for EOP 1980 history.
- clearEOP2000HistoryLoaders() - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Clear loaders for EOP 2000 history.
- clearEventHandlers() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventHandlers() - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventsDetectors() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Remove all events detectors.
- clearEventsDetectors() - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Remove all events detectors.
- clearEventsDetectors() - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Remove all events detectors.
- clearEventsDetectors() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Remove all events detectors.
- clearEventsDetectors() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Remove all events detectors.
- clearEventsDetectors() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Remove all events detectors.
- clearEventsDetectors() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Remove all events detectors.
- clearGeoMagneticModelReaders() - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticFieldFactory
-
Clear geomagnetic models readers.
- clearIEEEFlags() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Clears the IEEE 854 status flags.
- clearLoadedDataNames() - Method in class fr.cnes.sirius.patrius.data.DataProvidersManager
-
Clear the set of data file names that have been loaded.
- clearLoggedEvents() - Method in class fr.cnes.sirius.patrius.events.postprocessing.EventsLogger
-
Clear the logged events.
- clearLoggedEvents() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiEventsLogger
-
Clear the logged events.
- clearModels() - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticFieldFactory
-
Method to reset igrf and wmm models to null.
- clearObservations() - Method in class fr.cnes.sirius.patrius.math.fitting.CurveFitter
-
Remove all observations.
- clearOceanTidesCoefficientsReaders() - Static method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsFactory
-
Clear ocean tides coefficients READERS.
- clearPotentialCoefficientsReaders() - Static method in class fr.cnes.sirius.patrius.forces.gravity.potential.GravityFieldFactory
-
Clear gravity field READERS.
- clearProviders() - Method in class fr.cnes.sirius.patrius.data.DataProvidersManager
-
Remove all data providers.
- clearSelectedParameters() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Clear the selected parameters list.
- clearSolarActivityDataReaders() - Static method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataFactory
-
Clear solar activity READERS.
- clearSpiceBodyMapping() - Static method in class fr.cnes.sirius.patrius.bodies.bsp.BSPEphemerisLoader
-
Clear the SPICE Body mapping
- clearSpiceBodyMapping() - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceBody
-
Clear the SPICE body mapping.
- clearStepHandlers() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clearStepHandlers() - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clearTimeScales() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Clear the time scales (UTC, UT1 and GMST).
- clearUTCTAILoaders() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Clear loaders for UTC-TAI offsets history files.
- clearVariablePotentialCoefficientsReaders() - Static method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariableGravityFieldFactory
-
Clear readers
- clone() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalStateInfo
-
Copy of the AdditionalStateInfo.
- cloneMe() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Clone a linear problem request
- CLOSE_APPROACH_THRESHOLD - Static variable in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Close approach threshold.
- closeDAF(int) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandle
-
Close the DAF associated with a given handle.
- closeFile(int, String) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandleManager
-
Close the file associated with HANDLE.
- closeReplayFile() - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
Closes valuesFileURL after use in REPLAY_MODE.
- CLOSEST_ON_LINE - Static variable in class fr.cnes.sirius.patrius.bodies.BodyPoint.BodyPointName
-
Name for closest point on a line.
- CLOSEST_ON_SHAPE - Static variable in class fr.cnes.sirius.patrius.bodies.BodyPoint.BodyPointName
-
Name for closest point on shape.
- closestPoint(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Compute the point of the instance closest to another line.
- closestPointTo(Line, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
This method computes the two points, on the line and on the body, that are the closest to each other.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
This method computes the two points, on the line and on the body, that are the closest to each other.
- closestPointTo(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Vector3D) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Vector3D, String) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Line, Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
This method computes the two points, on the line and on the body, that are the closest to each other.
- closestPointTo(Line) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
This method computes the two points, on the line and on the body, that are the closest to each other.
- closestPointTo(Vector3D, Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Vector3D) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Vector3D, String) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Line, Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
This method computes the two points, on the line and on the body, that are the closest to each other.
- closestPointTo(Line) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
This method computes the two points, on the line and on the body, that are the closest to each other.
- closestPointTo(Vector3D, Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Vector3D) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Vector3D, String) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Line, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
This method computes the two points, on the line and on the body, that are the closest to each other.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
This method computes the two points, on the line and on the body, that are the closest to each other.
- closestPointTo(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Vector3D) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Vector3D, String) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Computes the point on body surface that is the closest to provided point.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Computes the points of the triangle and the line realizing the shortest distance.
- closestPointTo(Vector3D) - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Getter for the closest point of triangle to provided point.
- closestPointTo(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractEllipse
-
Computes the point on the ellipse closest to a point.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractEllipse
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Computes the point, on the ellipsoid surface, that is the closest to a point of space.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
This method computes the point on the line that is the closest to the ellipsoid.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCone
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCylinder
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Vector3D) - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.IEllipsoid
-
Computes the point, on the ellipsoid surface, that is the closest to a point of space.
- closestPointTo(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
Computes the closest point on the cone to a user specified point
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
Calculate the closest point to a line
- closestPointTo(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
Computes the closest point on the cone to a user specified point
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
Calculate closest point to a line
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCone
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCylinder
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCone
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCylinder
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Computes the points of this and another line realizing the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.LineSegment
-
Computation of the closest point to a line, and the associated point of the line;
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RectangleCone
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCone
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Shape
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Computes the points of the shape and the line realizing
the shortest distance.
- closestPointTo(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Computes the point, on the ellipsoid surface, that is the closest to a point of space.
- closestPointTo(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCap
-
Computes the points of the shape and the line realizing
the shortest distance.
- CLOSING_BRACKET - Static variable in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Closing bracket character (']').
- CLOSING_CURLY_BRACKET - Static variable in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Closing curly bracket character ('}').
- clpool() - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.PoolSpice
-
Clears the pool of kernel variables maintained by the kernel POOL subsystem.
- Cluster<T extends Clusterable<T>> - Class in fr.cnes.sirius.patrius.math.stat.clustering
-
- Cluster(T) - Constructor for class fr.cnes.sirius.patrius.math.stat.clustering.Cluster
-
Build a cluster centered at a specified point.
- cluster(Collection<T>) - Method in class fr.cnes.sirius.patrius.math.stat.clustering.DBSCANClusterer
-
Performs DBSCAN cluster analysis.
- cluster(Collection<T>, int, int, int) - Method in class fr.cnes.sirius.patrius.math.stat.clustering.KMeansPlusPlusClusterer
-
Runs the K-means++ clustering algorithm.
- cluster(Collection<T>, int, int) - Method in class fr.cnes.sirius.patrius.math.stat.clustering.KMeansPlusPlusClusterer
-
Runs the K-means++ clustering algorithm.
- Clusterable<T> - Interface in fr.cnes.sirius.patrius.math.stat.clustering
-
Interface for points that can be clustered together.
- CMAESOptimizer - Class in fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv
-
An implementation of the active Covariance Matrix Adaptation Evolution Strategy (CMA-ES) for non-linear, non-convex,
non-smooth, global function minimization.
- CMAESOptimizer(int, double, boolean, int, int, RandomGenerator, boolean, ConvergenceChecker<PointValuePair>) - Constructor for class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- CMAESOptimizer.PopulationSize - Class in fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv
-
Population size.
- CMAESOptimizer.Sigma - Class in fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv
-
Input sigma values.
- CNAVGNSSParameters - Class in fr.cnes.sirius.patrius.orbits.pvcoordinates
-
This class is a simple container for a broadcast model CNAV ephemeris description parameters of
GNSS satellites (GPS or BeiDou only)
- CNAVGNSSParameters(GNSSType, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.orbits.pvcoordinates.CNAVGNSSParameters
-
Creates an instance of GNSS Parameter for the CNAV broadcast model (for GPS or BeiDou only)
- CnCookModel - Class in fr.cnes.sirius.patrius.assembly.models.cook
-
This class implements Cook normal coefficient to a facet.
- CnCookModel(ExtendedAtmosphere, Facet, Frame, double, double) - Constructor for class fr.cnes.sirius.patrius.assembly.models.cook.CnCookModel
-
Constructor with constant wall gas temperature.
- CnCookModel(ExtendedAtmosphere, Facet, Frame, double, WallGasTemperatureProvider) - Constructor for class fr.cnes.sirius.patrius.assembly.models.cook.CnCookModel
-
Constructor.
- CNES_STELA_AE - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
CNES Stela reference equatorial radius.
- CNES_STELA_MU - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
CNES Stela reference mu.
- CNES_STELA_UA - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
UA from the 1992 Astronomical Almanac by P.
- code() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
Get a hashcode for this set.
- CodedEvent - Class in fr.cnes.sirius.patrius.events.postprocessing
-
This class represents an event occurrence.
- CodedEvent(String, String, AbsoluteDate, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.CodedEvent
-
Constructor for the coded event.
- CodedEventsList - Class in fr.cnes.sirius.patrius.events.postprocessing
-
This class represents a list of objects
CodedEvent.
- CodedEventsList() - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsList
-
Default constructor.
- CodedEventsLogger - Class in fr.cnes.sirius.patrius.events.postprocessing
-
This class logs coded events during propagation.
- CodedEventsLogger() - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsLogger
-
Default constructor.
- CodedEventsLogger.LoggedCodedEvent - Class in fr.cnes.sirius.patrius.events.postprocessing
-
This class is used to store the coded event with contextual information.
- CodingEventDetector - Interface in fr.cnes.sirius.patrius.events.postprocessing
-
This interface represents an event detector that is able to build a
CodedEvent object.
- coef - Variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
coef for SGP C3 computation.
- coef1 - Variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
coef for SGP C5 computation.
- coefficientsC - Variable in class fr.cnes.sirius.patrius.forces.gravity.tides.AbstractTides
-
First normalized potential tesseral coefficients array.
- coefficientsCPD - Variable in class fr.cnes.sirius.patrius.forces.gravity.tides.AbstractTides
-
First normalized potential tesseral coefficients array for partial derivatives computation.
- coefficientsS - Variable in class fr.cnes.sirius.patrius.forces.gravity.tides.AbstractTides
-
Second normalized potential tesseral coefficients array.
- coefficientsSPD - Variable in class fr.cnes.sirius.patrius.forces.gravity.tides.AbstractTides
-
Second normalized potential tesseral coefficients array for partial derivatives computation.
- coeffsSumOne(double, double, double) - Static method in class fr.cnes.sirius.patrius.assembly.vehicle.RadiativeProperties
-
Function to check if the absortion, specular and difusse coefficients sum is one.
- COFFileFormatReader - Class in fr.cnes.sirius.patrius.models.earth
-
Reader for COF file formats for geomagnetic models.
- COFFileFormatReader(String) - Constructor for class fr.cnes.sirius.patrius.models.earth.COFFileFormatReader
-
Constructor.
- collector(BivariateFunction, UnivariateFunction, double) - Static method in class fr.cnes.sirius.patrius.math.analysis.FunctionUtils
-
Returns a MultivariateFunction h(x[]) defined by
h(x[]) = combiner(...combiner(combiner(initialValue,f(x[0])),f(x[1]))...)
- collector(BivariateFunction, double) - Static method in class fr.cnes.sirius.patrius.math.analysis.FunctionUtils
-
Returns a MultivariateFunction h(x[]) defined by
h(x[]) = combiner(...combiner(combiner(initialValue,x[0]),x[1])...)
- Combinations - Class in fr.cnes.sirius.patrius.math.util
-
Utility to create
combinations (n, k) of
k elements in a set of
n elements.
- Combinations(int, int) - Constructor for class fr.cnes.sirius.patrius.math.util.Combinations
-
Creates an instance whose range is the k-element subsets of
{0, ..., n - 1} represented as int[] arrays.
- CombinatoricsUtils - Class in fr.cnes.sirius.patrius.math.util
-
Combinatorial utilities.
- combine(BivariateFunction, UnivariateFunction, UnivariateFunction) - Static method in class fr.cnes.sirius.patrius.math.analysis.FunctionUtils
-
Returns the univariate function
h(x) = combiner(f(x), g(x)).
- combine(double, double, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Returns a new vector representing a * this + b * y, the linear
combination of this and y.
- combine(double, double, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Returns a new vector representing a * this + b * y, the linear
combination of this and y.
- CombinedPhenomenaDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
This class finds the events resulting from the combination of two phenomena.
- CombinedPhenomenaDetector(EventDetector, boolean, EventDetector, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CombinedPhenomenaDetector
-
Constructor for the detector of the combination of two phenomena.
- CombinedPhenomenaDetector(EventDetector, boolean, EventDetector, boolean, boolean, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.CombinedPhenomenaDetector
-
Constructor for the detector of the combination of two phenomena.
- combineToSelf(double, double, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Updates this with the linear combination of this and y.
- combineToSelf(double, double, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Updates this with the linear combination of this and y.
- COMMA - Static variable in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Comma character (',').
- CommentSectionDAF - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
Class dedicated to the reading of the comment section of binary DAF files.
- ComparableInterval<T extends Comparable<T>> - Class in fr.cnes.sirius.patrius.math.interval
-
Class describing an interval of Comparable data.
- ComparableInterval(T, T) - Constructor for class fr.cnes.sirius.patrius.math.interval.ComparableInterval
-
- ComparableInterval(IntervalEndpointType, T, T, IntervalEndpointType) - Constructor for class fr.cnes.sirius.patrius.math.interval.ComparableInterval
-
Constructor.
- ComparableIntervalsList<T extends Comparable<T>> - Class in fr.cnes.sirius.patrius.math.interval
-
- ComparableIntervalsList() - Constructor for class fr.cnes.sirius.patrius.math.interval.ComparableIntervalsList
-
- comparator() - Method in class fr.cnes.sirius.patrius.math.util.Combinations
-
Defines a lexicographic ordering of combinations.
- comparatorPermutation(List<S>, Comparator<S>) - Static method in class fr.cnes.sirius.patrius.math.genetics.RandomKey
-
Generates a representation of a permutation corresponding to the data sorted by
comparator.
- Comparators - Class in fr.cnes.sirius.patrius.math
-
- Static comparison methods for real numbers
- Classical methods to compare doubles using an epsilon, as an input or with a default value
See DV-MATHS_30.
- compare(Attitude, Attitude) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeChronologicalComparator
-
Compare two Attitude instances.
- compare(Comparable<T>) - Method in class fr.cnes.sirius.patrius.math.interval.ComparableInterval
-
Compare provided comparable to this comparable interval.
- compare(TimeStamped, TimeStamped) - Method in class fr.cnes.sirius.patrius.time.ChronologicalComparator
-
Compare two time-stamped instances.
- compareDurationTo(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Checks if the duration of the interval is longer, shorter or equal to the duration of
another interval.
- compareLowerEndTo(ComparableInterval<T>) - Method in class fr.cnes.sirius.patrius.math.interval.ComparableInterval
-
Compares the lower end point with the lower end point of the given interval.
- compareTo(Attitude) - Method in class fr.cnes.sirius.patrius.attitudes.Attitude
-
Compare this attitude with another attitude.
- compareTo(Watcher) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.Watcher
- compareTo(CodedEvent) - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEvent
-
- compareTo(CodedEventsLogger.LoggedCodedEvent) - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsLogger.LoggedCodedEvent
-
Compare two LoggedCodedEvent with their internal date.
- compareTo(MultiCodedEventsLogger.MultiLoggedCodedEvent) - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiCodedEventsLogger.MultiLoggedCodedEvent
-
Compare two MultiLoggedCodedEvent with their internal date.
- compareTo(Phenomenon) - Method in class fr.cnes.sirius.patrius.events.postprocessing.Phenomenon
-
Compares the Phenomenon instances.
- compareTo(BigFraction) - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Compares this object to another based on size.
- compareTo(Fraction) - Method in class fr.cnes.sirius.patrius.math.fraction.Fraction
-
Compares this object to another based on size.
- compareTo(Chromosome) - Method in class fr.cnes.sirius.patrius.math.genetics.Chromosome
-
Compares two chromosomes based on their fitness.
- compareTo(OrderedTuple) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.OrderedTuple
-
Compares this ordered T-uple with the specified object.
- compareTo(ComparableInterval<T>) - Method in class fr.cnes.sirius.patrius.math.interval.ComparableInterval
-
Compares this interval with the specified interval.
- compareTo(BigReal) - Method in class fr.cnes.sirius.patrius.math.util.BigReal
- compareTo(Decimal64) - Method in class fr.cnes.sirius.patrius.math.util.Decimal64
-
The current implementation returns the same value as
new Double(this.doubleValue()).compareTo(new
Double(o.doubleValue()))
- compareTo(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.util.Precision
-
Compares two numbers given some amount of allowed error.
- compareTo(double, double, int) - Static method in class fr.cnes.sirius.patrius.math.util.Precision
-
Compares two numbers given some amount of allowed error.
- compareTo(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Compare the instance with another date.
- compareTo(DateComponents) - Method in class fr.cnes.sirius.patrius.time.DateComponents
- compareTo(DateTimeComponents) - Method in class fr.cnes.sirius.patrius.time.DateTimeComponents
- compareTo(TimeComponents) - Method in class fr.cnes.sirius.patrius.time.TimeComponents
- compareTo(TimeStampedAngularCoordinates) - Method in class fr.cnes.sirius.patrius.utils.TimeStampedAngularCoordinates
-
Compare this time stamped angular coordinates with another time stamped angular coordinates.
- compareUpperEndTo(ComparableInterval<T>) - Method in class fr.cnes.sirius.patrius.math.interval.ComparableInterval
-
Compares the upper end point with the upper end point of the given interval.
- complainIfNotSupported(String) - Method in class fr.cnes.sirius.patrius.math.ode.AbstractParameterizable
-
Check if a parameter is supported and throw an IllegalArgumentException if not.
- complement(int) - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Negate the mantissa of this by computing the complement.
- complementaryAngle(double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.math.interval.AngleTools
-
Computes the complementary (PI/2 - angle) of the input angle, and then tries to express it in the
input interval.
- Complex - Class in fr.cnes.sirius.patrius.math.complex
-
Representation of a Complex number, i.e. a number which has both a
real and imaginary part.
- Complex(double) - Constructor for class fr.cnes.sirius.patrius.math.complex.Complex
-
Create a complex number given only the real part.
- Complex(double, double) - Constructor for class fr.cnes.sirius.patrius.math.complex.Complex
-
Create a complex number given the real and imaginary parts.
- ComplexField - Class in fr.cnes.sirius.patrius.math.complex
-
Representation of the complex numbers field.
- ComplexFormat - Class in fr.cnes.sirius.patrius.math.complex
-
Formats a Complex number in cartesian format "Re(c) + Im(c)i".
- ComplexFormat() - Constructor for class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Create an instance with the default imaginary character, 'i', and the
default number format for both real and imaginary parts.
- ComplexFormat(NumberFormat) - Constructor for class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Create an instance with a custom number format for both real and
imaginary parts.
- ComplexFormat(NumberFormat, NumberFormat) - Constructor for class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Create an instance with a custom number format for the real part and a
custom number format for the imaginary part.
- ComplexFormat(String) - Constructor for class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Create an instance with a custom imaginary character, and the default
number format for both real and imaginary parts.
- ComplexFormat(String, NumberFormat) - Constructor for class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Create an instance with a custom imaginary character, and a custom number
format for both real and imaginary parts.
- ComplexFormat(String, NumberFormat, NumberFormat) - Constructor for class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Create an instance with a custom imaginary character, a custom number
format for the real part, and a custom number format for the imaginary
part.
- ComplexUtils - Class in fr.cnes.sirius.patrius.math.complex
-
Static implementations of common
Complex utilities functions.
- componentProvider(ElementaryMultiplicationTypes.ElementaryType, int, double) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.ElementaryMultiplicationTypes
-
- compose(double...) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Compute composition of the instance by a univariate function.
- compose(double[], int, double[], double[], int) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Compute composition of a derivative structure by a function.
- compose(UnivariateFunction...) - Static method in class fr.cnes.sirius.patrius.math.analysis.FunctionUtils
-
Composes functions.
- compose(UnivariateDifferentiableFunction...) - Static method in class fr.cnes.sirius.patrius.math.analysis.FunctionUtils
-
Composes functions.
- ComposedAttitudeLaw - Class in fr.cnes.sirius.patrius.attitudes
-
This class represents a composed attitude law, defined by a main attitude law provider and a chained list of
orientation laws.
- ComposedAttitudeLaw(AttitudeLaw, LinkedList<IOrientationLaw>) - Constructor for class fr.cnes.sirius.patrius.attitudes.ComposedAttitudeLaw
-
Builds a composed attitude law from a man attitude law provider and a list of modifier orientation laws.
- ComposedAttitudeLaw(AttitudeLaw, LinkedList<IOrientationLaw>, double) - Constructor for class fr.cnes.sirius.patrius.attitudes.ComposedAttitudeLaw
-
Builds a composed attitude law from a man attitude law provider and a list of modifier orientation laws.
- composeMatrix(RealMatrix[][]) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.AlgebraUtils
-
Constructs a block matrix made from the given parts.
- CompositeFormat - Class in fr.cnes.sirius.patrius.math.util
-
Base class for formatters of composite objects (complex numbers, vectors ...).
- compute(PVCoordinatesProvider, AttitudeProvider, AbsoluteDate, AttitudeProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.slew.ConstantSpinSlewComputer
-
Compute the slew.
- compute(PVCoordinatesProvider, AttitudeProvider, AbsoluteDate, AttitudeProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.slew.TwoSpinBiasSlewComputer
-
Compute the slew.
- compute(PVCoordinatesProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.radiation.LightingRatio
-
Compute lighting ratio.
- compute(UnivariateVectorFunction, double) - Method in class fr.cnes.sirius.patrius.math.filter.FIRFilter
-
Computes the filtered value of the given function at the given computation point.
- compute(MathArrays.Function) - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Performs an operation on the addressable elements of the array.
- computeAberrationAngle(Vector3D, Vector3D) - Static method in class fr.cnes.sirius.patrius.attitudes.directions.LightAberrationTransformation
-
Compute the light aberration angle between a light path direction seen from a frame F and a frame F'.
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.drag.DragForce
-
Compute the acceleration due to the force.
- computeAcceleration(PVCoordinates, Frame, Atmosphere, AbsoluteDate, double, double) - Static method in class fr.cnes.sirius.patrius.forces.drag.DragForce
-
Method to compute the acceleration.
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Compute the acceleration due to the force.
- computeAcceleration(PVCoordinates, LocalOrbitalFrame, Vector3D, Frame, SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Method to compute the acceleration.
- computeAcceleration(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.forces.ForceModel
-
Compute the acceleration due to the force.
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
Compute the acceleration due to the force.
- computeAcceleration(Vector3D, AbsoluteDate, Transform) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
Abstract method to compute the acceleration of the implementation
- computeAcceleration(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractHarmonicGravityModel
-
Compute the acceleration due to the gravitational attraction.
- computeAcceleration(Vector3D, AbsoluteDate, Transform) - Method in class fr.cnes.sirius.patrius.forces.gravity.DirectBodyAttraction
-
Abstract method to compute the acceleration of the implementation
- computeAcceleration(Vector3D, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.gravity.GravityModel
-
Compute the acceleration due to the gravitational attraction.
- computeAcceleration(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.GridGravityModel
-
Compute the acceleration due to the gravitational attraction.
- computeAcceleration(Vector3D, AbsoluteDate, Transform) - Method in class fr.cnes.sirius.patrius.forces.gravity.ThirdBodyAttraction
-
Abstract method to compute the acceleration of the implementation
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.AbstractTides
-
Compute the acceleration due to the force.
- computeAcceleration(PVCoordinates, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.AbstractTides
-
Method to compute the acceleration, from Balmino algorithm (see BalminoAttractionModel class).
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Compute the acceleration due to the force.
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Compute the acceleration due to the force.
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Compute the acceleration due to the force.
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Compute the acceleration due to the force.
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.relativistic.CoriolisRelativisticEffect
-
Compute the acceleration due to the force.
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.relativistic.LenseThirringRelativisticEffect
-
Compute the acceleration due to the force.
- computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.relativistic.SchwarzschildRelativisticEffect
-
Compute the acceleration due to the force.
- computeAcceleration(StelaEquinoctialOrbit, PVCoordinates) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Compute the acceleration due to the force.
- computeAnalytical() - Method in class fr.cnes.sirius.patrius.attitudes.slew.IsisSpinBiasSlewComputer
-
Compute the slew (analytical version).
- computeAnomalyBounds(double, double, double) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAtmosphericDrag
-
Computes true anomaly and eccentric anomaly bounds.
- computeAzimuthRate(PVCoordinates) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AzimuthElevationCalculator
-
Compute the azimuth rate of a point defined by its Cartesian coordinates in a
Frame whose x, y and "Reference Azimuth" axis are in the same Plane.
- computeBalminoAcceleration(Vector3D, double[][], double[][], double, double, int, int, HelmholtzPolynomial) - Static method in class fr.cnes.sirius.patrius.forces.gravity.GravityToolbox
-
- computeBearing(EllipsoidPoint, EllipsoidPoint) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute the bearing (azimuth) between two points.
- computeCartesianUnitPosition(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AzimuthElevationCalculator
-
Compute the cartesian unit vector corresponding to the provided azimuth/elevation angles.
- computeCartesianUnitPosition(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.CardanCalculator
-
Compute the cartesian unit vector corresponding to the provided cardan angles.
- computeCartesianUnitPV(double, double, double, double, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AzimuthElevationCalculator
-
Compute the cartesian unit vector corresponding to the provided azimuth/elevation angles and their derivatives.
- computeCartesianUnitPV(double, double, double, double, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.CardanCalculator
-
Compute the cartesian unit vector corresponding to the provided cardan angles.
- computeCDriftComponent(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Compute the normalized drift component of the C coefficient
- computeCenterPointAlongLoxodrome(EllipsoidPoint, EllipsoidPoint) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute center point between two points along a loxodrome.
- computeCentralTermAcceleration(Vector3D) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractHarmonicGravityModel
-
Compute the acceleration due to the central term of the gravitational attraction.
- computeCentralTermDAccDPos(Vector3D) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractHarmonicGravityModel
-
Compute acceleration derivatives with respect to the state parameters for the central term.
- computeCode(double, int, int) - Static method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
Computes code of data set.
- computeCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Calculate the coefficients of Lagrange polynomial from the
interpolation data.
- computeCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionNewtonForm
-
Calculate the normal polynomial coefficients given the Newton form.
- computeCoeffs(List<double[][][]>, int, int, double, double) - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaGaussContribution
-
Compute elements under integral for coefficients evaluation.
- computeCorrections(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.frames.configuration.tides.IERS2003TidalCorrection
-
Compute the partials of the tidal variations to the orthoweights.
- computeCorrelationMatrix(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.PearsonsCorrelation
-
Computes the correlation matrix for the columns of the
input matrix.
- computeCorrelationMatrix(double[][]) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.PearsonsCorrelation
-
Computes the correlation matrix for the columns of the
input rectangular array.
- computeCorrelationMatrix(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation matrix for the columns of the
input matrix.
- computeCorrelationMatrix(double[][]) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation matrix for the columns of the
input rectangular array.
- computeCosSin(PVCoordinates, Vector3D) - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Private method to compute the cos(nwt) and sin(nwt) values.
- computeCost(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
-
Computes the cost.
- computeCovarianceMatrix(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Compute a covariance matrix from a matrix whose columns represent
covariates.
- computeCovarianceMatrix(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns represent
covariates.
- computeCovarianceMatrix(double[][], boolean) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Compute a covariance matrix from a rectangular array whose columns represent
covariates.
- computeCovarianceMatrix(double[][]) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Create a covariance matrix from a rectangular array whose columns represent
covariates.
- computeCovariances(double[], double) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
-
Get the covariance matrix of the optimized parameters.
- computeCPeriodicComponent(double, double, double, double) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Compute the normalized periodic component of the C coefficient
- computeCunninghamAcceleration(Vector3D, double, double[][], double[][], int, int, double) - Static method in class fr.cnes.sirius.patrius.forces.gravity.GravityToolbox
-
Method to compute the acceleration.
- computeCurrentQuad(Orbit, double, int, int, int, int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
-
Private method to reduce cyclomatic complexity.
- computeDAccDPos(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractHarmonicGravityModel
-
Compute acceleration derivatives with respect to the position of the spacecraft.
- computeDAccDPos(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.DrozinerGravityModel
-
Compute acceleration derivatives with respect to the position of the spacecraft.
- computeDAccDPos(Vector3D, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.gravity.GravityModel
-
Compute acceleration derivatives with respect to the position of the spacecraft.
- computeDAccDPos(Vector3D, double, double, double[][], double[][]) - Static method in class fr.cnes.sirius.patrius.forces.gravity.GravityToolbox
-
Compute the partial derivatives of the acceleration (Cunningham algorithm) with respect to the position.
- computeDAccDPos(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.GridGravityModel
-
Compute acceleration derivatives with respect to the position of the spacecraft.
- computeDAzimuth(Vector3D) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AzimuthElevationCalculator
-
Compute the azimuth derivative of a point defined by its Cartesian coordinates in a Frame
whose x, y and "Reference Azimuth" axis are
in the same Plane.
- computeDElevation(Vector3D) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AzimuthElevationCalculator
-
Compute the elevation derivative of a point defined by its Cartesian coordinates in a
Frame whose x, y and "Reference Azimuth" axis are in the same Plane.
- computeDerivatives(SpacecraftState, TimeDerivativesEquations) - Method in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
-
Compute the derivatives related to the additional state parameters.
- computeDerivatives(double, double, Collection<Parameter>) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.ZernikePolynomial
-
Compute the derivatives of this zernike polynomial with respect to the provided parameters.
- computeDerivatives(double, double[], double[]) - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Compute the derivatives and check the number of evaluations.
- computeDerivatives(double, double[], double[]) - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get the current time derivative of the complete state vector.
- computeDerivatives(double, double[], double[]) - Method in class fr.cnes.sirius.patrius.math.ode.FirstOrderConverter
-
Get the current time derivative of the state vector.
- computeDerivatives(double, double[], double[]) - Method in interface fr.cnes.sirius.patrius.math.ode.FirstOrderDifferentialEquations
-
Get the current time derivative of the state vector.
- computeDerivatives(double, double[], double[], double[], double[]) - Method in interface fr.cnes.sirius.patrius.math.ode.SecondaryEquations
-
Compute the derivatives related to the secondary state parameters.
- computeDerivatives(SpacecraftState, TimeDerivativesEquations) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Compute the derivatives related to the additional state parameters.
- computeDerivatives(SpacecraftState, TimeDerivativesEquations) - Method in interface fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquations
-
Compute the derivatives related to the additional state parameters.
- computeDerivatives(StelaEquinoctialOrbit, double[], double[]) - Method in interface fr.cnes.sirius.patrius.stela.propagation.StelaAdditionalEquations
-
Compute the derivatives related to the additional state parameters.
- computeDerivatives(double, double[], double[]) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaDifferentialEquations
-
Get the current time derivative of the state vector.
- computeDerivatives(StelaEquinoctialOrbit, double[], double[]) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaPartialDerivativesEquations
-
Compute the derivatives related to the additional state parameters.
- computeDistribution() - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
Computes the empirical distribution using values from the file
in valuesFileURL, using the default number of bins.
- computeDistribution(int) - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
Computes the empirical distribution using values from the file
in valuesFileURL and binCount bins.
- computeDividedDifference(double[], double[]) - Static method in class fr.cnes.sirius.patrius.math.analysis.interpolation.DividedDifferenceInterpolator
-
Return a copy of the divided difference array.
- computeDriftFunction(AbsoluteDate, AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Compute drift function to provide to #computeCDriftComponent or #computeSDriftComponent
- computeDrozinerAcceleration(Vector3D, double[][], double[][], double, double, double, int, int) - Static method in class fr.cnes.sirius.patrius.forces.gravity.GravityToolbox
-
- computeDuration(PVCoordinatesProvider, AttitudeProvider, AbsoluteDate, AttitudeProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.slew.TwoSpinBiasSlewComputer
-
Computes the actual slew duration.
- computeDV(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.orbman.ImpulseDaManeuver
-
Method to compute the DV thanks to Keplerian parameters included in the Spacecraft state.
- computeDV(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.orbman.ImpulseDeManeuver
-
Method to compute the DV thanks to Keplerian parameters included in the Spacecraft state.
- computeDV(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.orbman.ImpulseDiManeuver
-
Method to compute the DV thanks to Keplerian parameters included in the Spacecraft state.
- computeDV(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.forces.maneuvers.orbman.ImpulseParKepManeuver
-
Method to compute the DV thanks to Keplerian parameters included in the Spacecraft state.
- computeDXangle(Vector3D, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.CardanCalculator
-
Get the X-angle derivative of a point wrt the local point (dX) expressed in the oriented topocentric frame.
- computeDYangle(Vector3D, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.CardanCalculator
-
Get the Y-angle derivative of a point wrt the local point (dY) expressed in the oriented topocentric frame.
- computeEccentricityFunction(StelaEquinoctialOrbit, TesseralQuad) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
-
Compute eccentricity function G(e) terms eabs(q)cos(qω), eabs(q)sin(qω) and its
derivatives with respect to ex and ey.
- computeElapsedPeriodic(AbsoluteDate) - Method in enum fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet.PeriodicComputationMethod
-
Compute the phase of the periodic function
- computeElectronicCont(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.ionosphere.BentModel
-
Computation of the electric content between the station and the satellite at a date.
- computeElevationCorrectionFromApparentElevation(AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.AngularCorrection
-
Compute the angular correction from the apparent elevation.
- computeElevationCorrectionFromApparentElevation(AbsoluteDate, double, double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.FiniteDistanceAngularCorrection
-
Compute the angular correction from the apparent elevation and distance.
- computeElevationCorrectionFromApparentElevation(AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.FiniteDistanceAngularCorrection
-
Compute the angular correction from the apparent elevation.
- computeElevationCorrectionFromApparentElevation(AbsoluteDate, double, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Compute the tropospheric correction from the apparent elevation and distance.
- computeElevationCorrectionFromApparentElevation(double, double, double, double, double, double, double, double) - Static method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Compute the tropospheric correction from the apparent elevation and the provided conditions.
- computeElevationCorrectionFromApparentElevation(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AzoulayModel
-
Compute the angular correction from the apparent elevation.
- computeElevationCorrectionFromGeometricElevation(AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.AngularCorrection
-
Compute the angular correction from the geometric elevation.
- computeElevationCorrectionFromGeometricElevation(AbsoluteDate, double, double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.FiniteDistanceAngularCorrection
-
Compute the angular correction from the geometric elevation and distance.
- computeElevationCorrectionFromGeometricElevation(AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.FiniteDistanceAngularCorrection
-
Compute the angular correction from the geometric elevation.
- computeElevationCorrectionFromGeometricElevation(AbsoluteDate, double, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Compute the tropospheric correction from the geometric elevation and distance.
- computeElevationCorrectionFromGeometricElevation(double, double, double, double, double, double, double, double, double, int) - Static method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Compute the tropospheric correction from the geometric elevation and the provided conditions.
- computeElevationCorrectionFromGeometricElevation(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AzoulayModel
-
Compute the angular correction from the geometric elevation.
- computeElevationRate(PVCoordinates) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AzimuthElevationCalculator
-
Compute the elevation rate of a point defined by its Cartesian coordinates in a
Frame whose x, y and "Reference Azimuth" axis are in the same Plane
- computeEquationOfTime(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.LocalTimeAngle
-
Compute equation of time in TIRF in the range [-43200s; 43200s].
- computeEquinoctialToCartesianJacobian(StelaEquinoctialOrbit) - Static method in class fr.cnes.sirius.patrius.stela.orbits.JacobianConverter
-
Computes Jacobian matrix from equinoctial to cartesian.
- computeEvenMeanPotential(int) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential U at a given order of development (even case).
- computeEvenParDerA(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to a (even
case).
- computeEvenParDerEx(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to ex (even
case).
- computeEvenParDerEy(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to ey (even
case).
- computeEvenParDerIx(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to ix (even
case).
- computeEvenParDerIy(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to iy (even
case).
- computeExp(Dfp, Dfp) - Static method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Compute exp(a).
- computeExtended(PVCoordinatesProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.radiation.LightingRatio
-
Compute extended lighting ratio.
- computeF(StelaEquinoctialOrbit, TesseralQuad) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
-
Compute inclination function F and its partial derivatives with respect to ix and iy.
- computeFundamentalArguments(AbsoluteDate, TidesStandards.TidesStandard) - Static method in class fr.cnes.sirius.patrius.forces.gravity.tides.TidesToolbox
-
Method to compute the Doodson fundamental arguments.
- computeGaussDerivativeEquations(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaGaussContribution
-
Computation of the Gauss equation derivatives matrix in TNW frame.
- computeGaussEquations(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaGaussContribution
-
Compute the TNW Gauss Equation for GTO.
- computeGeographicMagneticCoefficients() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Compute Legendre polynomials coefficients with respect to geographic and magnetic poles.
- computeGeometricalProperties() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.IntervalsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.PolyhedronsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Compute some geometrical properties.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.drag.DragForce
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in interface fr.cnes.sirius.patrius.forces.GradientModel
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTides
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.PoleTides
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.TerrestrialTides
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.relativistic.CoriolisRelativisticEffect
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.relativistic.LenseThirringRelativisticEffect
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientPosition() - Method in class fr.cnes.sirius.patrius.forces.relativistic.SchwarzschildRelativisticEffect
-
This method returns true if the acceleration partial derivatives with
respect to position have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.drag.DragForce
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in interface fr.cnes.sirius.patrius.forces.GradientModel
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.AbstractTides
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.relativistic.CoriolisRelativisticEffect
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.relativistic.LenseThirringRelativisticEffect
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGradientVelocity() - Method in class fr.cnes.sirius.patrius.forces.relativistic.SchwarzschildRelativisticEffect
-
This method returns true if the acceleration partial derivatives with
respect to velocity have to be computed.
- computeGroundRefractivity(double, double, double) - Static method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Compute the ground refractivity by taking into account elevation, pressure and temperature.
- computeHashCode() - Method in enum fr.cnes.sirius.patrius.math.interval.IntervalEndpointType
-
Computes hash code for the instance (13 if the instance is OPEN and 37 if the instance is CLOSED)
- computeHelmholtzPolynomial(Vector3D) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.HelmholtzPolynomial
-
Calculate the value of the polynomial in a given point.
- computeIf(Predicate<CacheEntry<K, V>>, Supplier<CacheEntry<K, V>>) - Method in class fr.cnes.sirius.patrius.tools.cache.FIFOThreadSafeCache
-
Computes and add a new entry in the cache, if necessary.
- computeIfAbsent(K, Supplier<CacheEntry<K, V>>) - Method in class fr.cnes.sirius.patrius.tools.cache.FIFOThreadSafeCache
-
Computes and add a new entry in the cache, if necessary.
- computeInOutEccentricAnom(StelaEquinoctialOrbit, double, double) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Computation of In/Out eccentric anomalies.
- computeInOutTrueAnom(StelaEquinoctialOrbit, PVCoordinates) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Computation of in and out true anomalies of the shadowed part of the orbit.
- computeInterpolatedStateAndDerivatives(double, double) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.RungeKutta6StepInterpolator
-
Compute the state and derivatives at the interpolated time.
- computeInterpolatedStateAndDerivatives(double, double) - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Compute the state and derivatives at the interpolated time.
- computeInterpolatedStateAndDerivatives(double, double) - Method in class fr.cnes.sirius.patrius.math.ode.sampling.NordsieckStepInterpolator
-
Compute the state and derivatives at the interpolated time.
- computeInverseMeridionalDistance(double, OneAxisEllipsoid) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute the ellipsoid latitude, from a distance from the equator.
- computeInverseRectifyingLatitude(double, OneAxisEllipsoid) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
compute ellipsoid latitude at a given rectifying latitude. rectifying latitude -> giving sphere that has correct
distances along the meridians.
- computeJ10(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 10th degree development of the Zonal Perturbation.
- computeJ11(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 11th degree development of the Zonal Perturbation.
- computeJ12(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 12th degree development of the Zonal Perturbation.
- computeJ13(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 13th degree development of the Zonal Perturbation.
- computeJ14(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 14th degree development of the Zonal Perturbation.
- computeJ15(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 15th degree development of the Zonal Perturbation.
- computeJ2(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 2nd degree development of the Zonal Perturbation.
- computeJ2(StelaEquinoctialOrbit, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 2nd degree development of the Zonal Perturbation with specific mu.
- computeJ2PartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the partial derivatives due to J2 Potential effect.
- computeJ2ShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the short periods linked to J2 Potential effect.
- computeJ2Square(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.AbstractStelaZonalAttraction
-
Compute the effect of the J2² of the Zonal Perturbation.
- computeJ2Square(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalAttraction
-
Compute the effect of the J2² of the Zonal Perturbation.
- computeJ2Square(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the J2² of the Zonal Perturbation.
- computeJ2SquarePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the partial derivatives due to J2² Potential effect.
- computeJ3(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 3rd degree development of the Zonal Perturbation.
- computeJ3(StelaEquinoctialOrbit, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 3rd degree development of the Zonal Perturbation with specific mu.
- computeJ3PartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the partial derivatives due to J3 Potential effect.
- computeJ4(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 4th degree development of the Zonal Perturbation.
- computeJ4PartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the partial derivatives due to J4 Potential effect.
- computeJ5(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 5th degree development of the Zonal Perturbation.
- computeJ5PartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the partial derivatives due to J5 Potential effect.
- computeJ6(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 6th degree development of the Zonal Perturbation.
- computeJ6PartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the partial derivatives due to J6 Potential effect.
- computeJ7(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 7th degree development of the Zonal Perturbation.
- computeJ7PartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the partial derivatives due to J7 Potential effect.
- computeJ8(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 8th degree development of the Zonal Perturbation.
- computeJ9(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the effect of the 9th degree development of the Zonal Perturbation.
- computeJacobian(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.JacobianMultivariateVectorOptimizer
-
Computes the Jacobian matrix.
- computeJacobianCartesianWrtTrue() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Compute the Jacobian of the Cartesian parameters with respect to the orbital parameters with
true angle.
- computeJacobianCartesianWrtTrue() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Compute the Jacobian of the Cartesian parameters with respect to the orbital parameters with
true angle.
- computeJacobianEccentricWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
- computeJacobianEccentricWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
- computeJacobianEccentricWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
- computeJacobianEccentricWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
- computeJacobianEccentricWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
- computeJacobianEccentricWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
- computeJacobianEccentricWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
- computeJacobianEccentricWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
- computeJacobianEccentricWrtCartesian() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
- computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
- computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
- computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
- computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
- computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
- computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
- computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
- computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
- computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
- computeJacobianTrueWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
- computeJacobianTrueWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
- computeJacobianTrueWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
- computeJacobianTrueWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
- computeJacobianTrueWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
- computeJacobianTrueWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
- computeJacobianTrueWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
- computeJacobianTrueWrtCartesian() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
- computeJacobianTrueWrtCartesian() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
- computeLagrangeDerivativeEquations(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.StelaLagrangeEquations
-
Computation of the Lagrange equation derivatives matrix (Poisson Bracket derivatives).
- computeLagrangeEquations(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.StelaLagrangeEquations
-
Compute the Lagrange Equation for GTO (Poisson Bracket).
- computeLagrangeEquations(StelaEquinoctialOrbit, double) - Method in class fr.cnes.sirius.patrius.stela.forces.StelaLagrangeEquations
-
Compute the Lagrange Equation for GTO (Poisson Bracket) with specific mu.
- computeLimitVisibilityPoint(double, double, double) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Compute the limit visibility point for a satellite in a given direction.
- computeLinkBudget(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.RFLinkBudgetModel
-
Computes the link budget at a given date.
- computeLinkBudget(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.RFLinkBudgetModel
-
Computes the link budget at a given date.
- computeLLHRates(BodyShape, PVCoordinates, Frame, AbsoluteDate) - Method in enum fr.cnes.sirius.patrius.bodies.LLHCoordinatesSystem
-
Computes the rates in LLH coordinates (longitude, latitude, height) from the provided
PVCoordinates and date using finite differences.
- computeLn(Dfp, Dfp, Dfp) - Static method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Compute ln(a).
- computeLocalTime(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.BodyPointLocalTimeAngleDetector
-
Compute the local time.
- computeLocalTime(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.LocalTimeAngleDetector
-
Compute the local time.
- computeLosF107(StelaSpaceObject, SpacecraftState) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaLOSConstantSolarActivity
-
Updates the F107 coefficient for MEAN_CONSTANT solar activity.
- computeLoxodromicDistance(EllipsoidPoint, EllipsoidPoint) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Loxodromic distance between P1 and P2.This is the distance of constant bearing (or along a line in Mercator).
- computeMainStateJacobian(double, double[], double[], double[][]) - Method in interface fr.cnes.sirius.patrius.math.ode.MainStateJacobianProvider
-
Compute the jacobian matrix of ODE with respect to main state.
- computeMaxDuration() - Method in class fr.cnes.sirius.patrius.attitudes.slew.TwoSpinBiasSlewComputer
-
Estimate the maximum duration of the slew, before computing it.
- computeMeanLocalTimeAngle(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.time.LocalTimeAngle
-
Compute mean local time angle in TIRF frame in the range [-Π, Π[.
- computeMeanLocalTimeAngle(Orbit) - Method in class fr.cnes.sirius.patrius.time.LocalTimeAngle
-
Compute mean local time angle in TIRF frame in the range [-Π, Π[.
- computeMercatorLatitude(double, OneAxisEllipsoid) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute crescent latitude (Le) at a given ellipsoid latitude. also called Mercator latitude.
- computeMeridionalDistance(double, OneAxisEllipsoid) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute the distance from a given ellipsoid latitude to the equator, along a meridian.
- computeMinAngle(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.FieldAngularFace
-
Computes the minimal angle between this and a given direction.
- computeMinDistToMaskingBodies(AbsoluteDate, PVCoordinatesProvider, LinkTypeHandler.SignalPropagationRole, Frame, Vector3D, List<BodyShape>, AbstractSignalPropagationDetector.PropagationDelayType, double, int) - Static method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the minimal euclidian distance to the celestial body shapes.
- computeNonCentralTermsAcceleration(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractHarmonicGravityModel
-
Compute the acceleration due to the non-central terms of the gravitational attraction.
- computeNonCentralTermsAcceleration(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.BalminoGravityModel
-
Compute the acceleration due to the non-central terms of the gravitational attraction.
- computeNonCentralTermsAcceleration(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
Compute the acceleration due to the non-central terms of the gravitational attraction.
- computeNonCentralTermsAcceleration(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.DrozinerGravityModel
-
Compute the acceleration due to the non-central terms of the gravitational attraction.
- computeNonCentralTermsAcceleration(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.NewtonianGravityModel
-
Compute the acceleration due to the non-central terms of the gravitational attraction.
- computeNonCentralTermsAcceleration(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.VariablePotentialGravityModel
-
Compute the acceleration due to the non-central terms of the gravitational attraction.
- computeNonCentralTermsDAccDPos(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractHarmonicGravityModel
-
Compute acceleration derivatives with respect to the state parameters for the non-central terms.
- computeNonCentralTermsDAccDPos(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.BalminoGravityModel
-
Compute acceleration derivatives with respect to the state parameters for the non-central terms.
- computeNonCentralTermsDAccDPos(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
Compute acceleration derivatives with respect to the state parameters for the non-central terms.
- computeNonCentralTermsDAccDPos(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.DrozinerGravityModel
-
Compute acceleration derivatives with respect to the state parameters for the non-central terms.
- computeNonCentralTermsDAccDPos(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.NewtonianGravityModel
-
Compute acceleration derivatives with respect to the state parameters for the non-central terms.
- computeNonCentralTermsDAccDPos(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.VariablePotentialGravityModel
-
Compute acceleration derivatives with respect to the state parameters for the non-central terms.
- computeNormal() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Method to compute normal direction in body frame, to be implemented in each specific child class of
AbstractBodyPoint.
- computeNormal() - Method in class fr.cnes.sirius.patrius.bodies.EllipsoidPoint
-
Method to compute normal direction in body frame, to be implemented in each specific child class of
AbstractBodyPoint.
- computeNormal() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetPoint
-
Method to compute normal direction in body frame, to be implemented in each specific child class of
AbstractBodyPoint.
- computeNumerical() - Method in class fr.cnes.sirius.patrius.attitudes.slew.IsisSpinBiasSlewComputer
-
Compute the slew (numerical version).
- computeNutationArguments(double, TidesStandards.TidesStandard) - Static method in class fr.cnes.sirius.patrius.forces.gravity.tides.TidesToolbox
-
Method to compute the fundamental arguments from the luni-solar nutation theory.
- computeObjectiveGradient(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.GradientMultivariateOptimizer
-
Compute the gradient vector.
- computeObjectiveValue(double) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
Compute the objective function value.
- computeObjectiveValue(double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Compute the objective function value.
- computeObjectiveValue(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.MultivariateOptimizer
-
Computes the objective function value.
- computeObjectiveValue(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.MultivariateVectorOptimizer
-
Computes the objective function value.
- computeObjectiveValue(double) - Method in class fr.cnes.sirius.patrius.math.optim.univariate.UnivariateOptimizer
-
Computes the objective function value.
- computeObjectiveValueAndDerivative(double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.AbstractUnivariateDifferentiableSolver
-
Compute the objective function value.
- computeOddMeanPotential(int) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential U at a given order of development (odd case).
- computeOddParDerA(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to a (odd
case).
- computeOddParDerEx(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to ex (odd
case).
- computeOddParDerEy(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to ey (odd
case).
- computeOddParDerIx(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to ix (odd
case).
- computeOddParDerIy(int, double) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Compute the mean potential (at a given order of development) partial derivatives with respect to iy (odd
case).
- computeOmega(PVCoordinates) - Method in enum fr.cnes.sirius.patrius.frames.LOFType
-
Get the rotation rate vector expressed in inertial frame.
- computeOmega(AbsoluteDate, Frame, Frame) - Method in class fr.cnes.sirius.patrius.stela.forces.noninertial.NonInertialContribution
-
Compute rotation vector of frame2 with respect to frame1 expressed in frame2,
which is the rotation vector from frame1 to frame2.
- computeOmegaDerivative(AbsoluteDate, Frame, Frame, double) - Method in class fr.cnes.sirius.patrius.stela.forces.noninertial.NonInertialContribution
-
Compute rotation vector derivative from frame1 to frame2 using finite differences.
- computeOOPrime(double, double, double) - Static method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Compute the OO' distance.
- computeOrthodromicDistance(EllipsoidPoint, EllipsoidPoint) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute the orthodromic distance between two points.
- computeOrthodromicDistance(double, double, double, double, OneAxisEllipsoid) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute the orthodromic distance.
- computeParallaxCorrection(double, double, double) - Static method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Compute the parallax correction due to a finite distance object.
- computeParameterJacobian(double, double[], double[], String, double[]) - Method in interface fr.cnes.sirius.patrius.math.ode.ParameterJacobianProvider
-
Compute the Jacobian matrix of ODE with respect to one parameter.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAtmosphericDrag
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalAttraction
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaThirdBodyAttraction
-
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.noninertial.NonInertialContribution
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPPotential
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.StelaSRPSquaring
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivatives(StelaEquinoctialOrbit) - Method in interface fr.cnes.sirius.patrius.stela.forces.StelaForceModel
-
Compute the partial derivatives for a given spacecraft state.
- computePartialDerivativesWrtPosition - Variable in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
True if acceleration partial derivatives with respect to position have to be computed.
- computePathDelay(double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.FixedDelayModel
-
Calculates the tropospheric path delay for the signal path from a ground station to a satellite.
- computePeriodicFunctions(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Compute periodic functions to provide to #computeCPeriodicComponent or #computeSPeriodicComponent
- computePerturbation(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaGaussContribution
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaLagrangeContribution
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAtmosphericDrag
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalAttraction
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaThirdBodyAttraction
-
- computePerturbation(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.noninertial.NonInertialContribution
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPPotential
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePerturbation(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.StelaSRPSquaring
-
Compute the dE/dt force derivatives for a given spacecraft state.
- computePointAlongLoxodrome(EllipsoidPoint, double, double) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute the point coordinates from an origin point, an azimuth and a distance along the rhumb line (Loxodrome).
- computePointAlongOrthodrome(EllipsoidPoint, double, double) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute a point along orthodrome, from a point p1, at a distance d, in a
direction defined from an azimuth.
- computePositionFromEllipsodeticCoordinates(double, double, double) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Compute the position from the ellipsodetic coordinates in body frame.
- computePositionFromEllipsodeticCoordinates(double, double, double) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Compute the position from the ellipsodetic coordinates in body frame.
- computePositionFromEllipsodeticCoordinates(double, double, double) - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
Compute the position from the ellipsodetic coordinates in body frame.
- computePositionHeightCoordinateSignum(Vector3D, BodyPoint) - Static method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Return the expected signum for the position height coordinate.
- computePotential(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.GridGravityModel
-
Compute the potential due to the body attraction.
- computePotentialPerturbation(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.StelaSRPSquaring
-
- computeQuadElements(double[][], double[], int, int) - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaGaussContribution
-
Compute elements under integral for coefficients evaluation.
- computeRAANFromMeanLocalTime(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.time.LocalTimeAngle
-
Compute RAAN from mean local time angle.
- computeRAANFromTrueLocalTime(AbsoluteDate, double, Frame) - Method in class fr.cnes.sirius.patrius.time.LocalTimeAngle
-
Compute RAAN from true local time angle
- computeRadialZernikeMonomials(int, double) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.ZernikePolynomial
-
Compute the radial zernike monomials.
- computeRadiusEastWest(double, OneAxisEllipsoid) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute radius of curvature section East/West (also called M or Re).
- computeRawP(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
-
Compute radiation coefficient.
- computeResiduals(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
-
Computes the residuals.
- computeRoots(int) - Method in class fr.cnes.sirius.patrius.math.complex.RootsOfUnity
-
Computes the n-th roots of unity.
- computeRule(int) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.gauss.BaseRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.gauss.LegendreHighPrecisionRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.gauss.LegendreRuleFactory
-
Computes the rule for the given order.
- computeSC(SpacecraftState, Frame, Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.GlobalAeroModel
-
Compute the surface drag coefficient (drag coefficient x area)
- computeSDriftComponent(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Compute the normalized drift component of the S coefficient
- computeSecondDerivatives(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
-
Compute the second derivatives related to the additional state parameters.
- computeSecondDerivatives(double, double[], double[], double[]) - Method in interface fr.cnes.sirius.patrius.math.ode.SecondOrderDifferentialEquations
-
Get the current time derivative of the state vector.
- computeSecondDerivatives(SpacecraftState) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Compute the second derivatives related to the additional state parameters.
- computeSecondDerivatives(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquations
-
Compute the second derivatives related to the additional state parameters.
- computeSecular(Orbit, AbstractLyddanePropagator.LyddaneParametersType) - Method in class fr.cnes.sirius.patrius.propagation.analytical.AbstractLyddanePropagator
-
Compute secular orbit in body frame from provided orbit.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAtmosphericDrag
-
Compute the short periodic variations for a given spacecraft state.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalAttraction
-
Compute the short periodic variations for a given spacecraft state.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
-
Compute the short periodic variations for a given spacecraft state.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
-
Compute the short periodic variations for a given spacecraft state.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaThirdBodyAttraction
-
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Compute the short periodic variations for a given spacecraft state.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.noninertial.NonInertialContribution
-
Compute the short periodic variations for a given spacecraft state.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPPotential
-
Compute the short periodic variations for a given spacecraft state.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Compute the short periodic variations for a given spacecraft state.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.StelaSRPSquaring
-
Compute the short periodic variations for a given spacecraft state.
- computeShortPeriods(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in interface fr.cnes.sirius.patrius.stela.forces.StelaForceModel
-
Compute the short periodic variations for a given spacecraft state.
- computeSideDirections(Frame) - Method in class fr.cnes.sirius.patrius.fieldsofview.PyramidalField
-
Retrieve the directions delimiting the pyramidal field of view.
- computeSigma(double[], double) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
-
Computes an estimate of the standard deviation of the parameters.
- computeSignalDelay(double, AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.ionosphere.BentModel
-
Calculates the ionospheric signal delay for the signal path from the position
of the transmitter and the receiver and the current date.
- computeSignalDelay(double, AbsoluteDate, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.signalpropagation.ionosphere.IonosphericCorrection
-
Calculates the ionospheric signal delay for the signal path from the position
of the transmitter and the receiver and the current date.
- computeSignalDelay(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AzoulayModel
-
Calculates the tropospheric signal delay for the signal path from a ground station to a
satellite at a given date.
- computeSignalDelay(double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.FixedDelayModel
-
Calculates the tropospheric signal delay for the signal path from a ground station to a satellite.
- computeSignalDelay(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.FixedDelayModel
-
Calculates the tropospheric signal delay for the signal path from a ground station to a
satellite at a given date.
- computeSignalDelay(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.MariniMurrayModel
-
Calculates the tropospheric signal delay for the signal path from a ground station to a
satellite at a given date.
- computeSignalDelay(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.SaastamoinenModel
-
Calculates the tropospheric signal delay for the signal path from a ground station to a
satellite at a given date.
- computeSignalDelay(AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.troposphere.TroposphericCorrection
-
Calculates the tropospheric signal delay for the signal path from a ground station to a
satellite at a given date.
- computeSignalPropagation(PVCoordinatesProvider, PVCoordinatesProvider, AbsoluteDate, VacuumSignalPropagationModel.FixedDate) - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagationModel
-
Computes the signal propagation object in the void at a particular date
- computeSPeriodicComponent(double, double, double, double) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Compute the normalized periodic component of the S coefficient
- computeSphericalAzimuth(EllipsoidPoint, EllipsoidPoint) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Compute the spherical azimuth (clock wise) between two points.
- computeSpinByFD(PVCoordinatesProvider, Frame, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.attitudes.AttitudeLeg
-
Compute the rotation rate vector at a given date by finite differences (using 2nd order centered finite
differences).
- computeSpinByFD(PVCoordinatesProvider, Frame, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.attitudes.AttitudeProvider
-
Compute the rotation rate vector at a given date by finite differences (using 2nd order centered finite
differences).
- computeSpinByFD(PVCoordinatesProvider, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLeg
-
Compute the orientation derivative at a given date by finite differences (using 2nd order centered finite
differences).
- computeSpinByFD(PVCoordinatesProvider, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProvider
-
Compute the orientation derivative at a given date by finite differences (using 2nd order centered finite
differences).
- computeSpinDerivativeByFD(PVCoordinatesProvider, Frame, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.attitudes.AttitudeLeg
-
Compute the rotation acceleration vector at a given date by finite differences (using 2nd order centered finite
differences).
- computeSpinDerivativeByFD(PVCoordinatesProvider, Frame, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.attitudes.AttitudeProvider
-
Compute the rotation acceleration vector at a given date by finite differences (using 2nd order centered finite
differences).
- computeSpinDerivativeByFD(PVCoordinatesProvider, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLeg
-
Compute the orientation acceleration vector at a given date by finite differences
(using 2nd order centered finite differences).
- computeSpinDerivativeByFD(PVCoordinatesProvider, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProvider
-
Compute the orientation acceleration vector at a given date by finite differences
(using 2nd order centered finite differences).
- computeSpinNumerical(double, double, double) - Static method in interface fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProvider
-
Computes the spin as a finite difference given two angles and the computation step between them.
- computeSquaringPoints(int, StelaEquinoctialOrbit, double, double) - Method in class fr.cnes.sirius.patrius.stela.forces.Squaring
-
Computation of squaring points equally distributed according to true anomaly.
- computeSquaringPointsEccentric(int, StelaEquinoctialOrbit) - Static method in class fr.cnes.sirius.patrius.stela.forces.Squaring
-
Computation of squaring points equally distributed according to eccentric anomaly.
- computeSquaringPointsEccentric2(int, StelaEquinoctialOrbit, double, double) - Static method in class fr.cnes.sirius.patrius.stela.forces.Squaring
-
Computation of squaring points equally distributed according to eccentric anomaly between start point and end
point.
- computeStandardValues(MeteorologicalConditions, double, double) - Static method in class fr.cnes.sirius.patrius.signalpropagation.MeteorologicalConditions
-
Computes standard model values [P, T, RH] for provided altitude given reference values
[P0, T0, RH0 H0] with:
P = pressure [Pa]
T = temperature [K]
RH = relative humidity [%]
- computeStandardValues(double) - Static method in class fr.cnes.sirius.patrius.signalpropagation.MeteorologicalConditions
-
Computes standard model values [P, T, R] for provided altitude with standard reference values
[P0, T0, RH0] provided by tropospheric models :
P = pressure [Pa] - P0 = 101325 [Pa]
T = temperature [K] - T0 = 18 [°C]
RH = humidity rate [%] - RH0 = 50 [%]
- computeStatisticsForAltitude(OneAxisEllipsoid) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShapeStatistics
-
Compute the summary of the distances between the altitude of each facet body shape vertex to a reference
ellipsoid surface.
- computeStatisticsForRadialDistance(OneAxisEllipsoid) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShapeStatistics
-
Compute the summary of the distances between the radius at each facet body shape
vertex and a reference ellipsoid radius in the same direction.
- computeStep(AbsoluteDate, AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeEphemerisGenerator
-
Computes the step used during attitude ephemeris generation.
- computeStep(AbsoluteDate, AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.FixedStepAttitudeEphemerisGenerator
-
Computes the step used during attitude ephemeris generation.
- computeStep(AbsoluteDate, AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.VariableStepAttitudeEphemerisGenerator
-
Computes the step used during the variable step ephemeris generation.
- computeStepGrowShrinkFactor(double) - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Compute step grow/shrink factor according to normalized error.
- computeSunBetaPhi(StelaEquinoctialOrbit, PVCoordinates) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Computation of Sun's right ascension (φ) and declination (β) wrt the orbit plane.
- computeSunSatAngle(Vector3D, Vector3D) - Method in class fr.cnes.sirius.patrius.events.detectors.LocalTimeAngleDetector
-
Compute the angle between the sun and the satellite projections over the equatiorial plane
- computeTorque(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.DragWrench
-
Compute the resulting torque at the mass centre of the spacecraft in the frame of the main part.
- computeTorque(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.DragWrench
-
Compute the resulting wrench.
- computeTorque(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.GenericWrenchModel
-
Compute the resulting torque at the mass centre of the spacecraft in the frame of the main part.
- computeTorque(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.GenericWrenchModel
-
Compute the resulting wrench.
- computeTorque(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.GravitationalAttractionWrench
-
Compute the resulting torque at the mass centre of the spacecraft in the frame of the main part.
- computeTorque(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.GravitationalAttractionWrench
-
Compute the resulting wrench.
- computeTorque(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.MagneticWrench
-
Compute the resulting torque at the mass centre of the spacecraft in the frame of the main part.
- computeTorque(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.MagneticWrench
-
Compute the resulting wrench.
- computeTorque(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
-
Compute the resulting torque at the mass centre of the spacecraft in the frame of the main part.
- computeTorque(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
-
Compute the resulting wrench.
- computeTorque(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.wrenches.WrenchModel
-
Compute the resulting torque at the mass centre of the spacecraft in the frame of the main part.
- computeTorque(SpacecraftState, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.wrenches.WrenchModel
-
Compute the resulting wrench.
- computeTprop(double, Vector3D, Vector3D) - Method in enum fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagationModel.ConvergenceAlgorithm
-
Recompute the signal propagation duration with the convergence algorithm.
- computeTrueLocalTimeAngle(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.time.LocalTimeAngle
-
Compute true local time angle in TIRF frame in the range [-Π, Π[.
- computeTrueLocalTimeAngle(Orbit) - Method in class fr.cnes.sirius.patrius.time.LocalTimeAngle
-
Compute true local time angle in TIRF frame in the range [-Π, Π[.
- computeValue(double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.ZernikePolynomial
-
Compute the value of this zernike polynomial.
- computeValueAndDerivatives(double, double, Collection<Parameter>) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.ZernikePolynomial
-
Compute the value and partial derivatives.
- computeWeightedJacobian(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
-
Computes the weighted Jacobian matrix.
- computeWrench(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.DragWrench
-
Compute the resulting wrench at the mass centre of the spacecraft in the frame of the main part.
- computeWrench(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.DragWrench
-
Compute the resulting wrench.
- computeWrench(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.GenericWrenchModel
-
Compute the resulting wrench at the mass centre of the spacecraft in the frame of the main part.
- computeWrench(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.GenericWrenchModel
-
Compute the resulting wrench.
- computeWrench(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.GravitationalAttractionWrench
-
Compute the resulting wrench at the mass centre of the spacecraft in the frame of the main part.
- computeWrench(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.GravitationalAttractionWrench
-
Compute the resulting wrench.
- computeWrench(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.MagneticWrench
-
Compute the resulting wrench at the mass centre of the spacecraft in the frame of the main part.
- computeWrench(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.MagneticWrench
-
Compute the resulting wrench.
- computeWrench(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
-
Compute the resulting wrench at the mass centre of the spacecraft in the frame of the main part.
- computeWrench(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
-
Compute the resulting wrench.
- computeWrench(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.wrenches.WrenchModel
-
Compute the resulting wrench at the mass centre of the spacecraft in the frame of the main part.
- computeWrench(SpacecraftState, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.wrenches.WrenchModel
-
Compute the resulting wrench.
- computeXangle(Vector3D, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.CardanCalculator
-
Compute the X-angle of a point given in cartesian coordinates in a local topocentric frame.
- computeXangleRate(PVCoordinates, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.CardanCalculator
-
Compute the X-angle rate of a point given in Cartesian coordinates in the local topocentric frame.
- computeXVariable(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AbstractAeroCoeff1D
-
Computes the x variable from the spacecraft state.
- computeXVariable(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAltitude
-
Computes the x variable from the spacecraft state.
- computeXVariable(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAoA
-
Computes the x variable from the spacecraft state.
- computeXVariable(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByMach
-
Computes the x variable from the spacecraft state.
- computeYangle(Vector3D, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.CardanCalculator
-
Compute the Y-angle of a point given in Cartesian coordinates in the local topocentric frame.
- computeYangleRate(PVCoordinates, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.CardanCalculator
-
Compute the Y-angle rate of a point given in Cartesian coordinates in the local topocentric frame.
- computeZernikeMonomials(int, double, double) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.ZernikePolynomial
-
Compute the zernike monomials.
- concatenate(List<Parameter>) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Concatenate a list of parameters with the already existing selectedParameters list
Check that the parameter to add is not already on the list (to avoid problems with the step)
- concatenateDiagonally(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Diagonally concatenates this matrix and another matrix m, placing it in the lower
right part of the concatenated matrix.
- concatenateDiagonally(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Diagonally concatenates this matrix and another matrix m, placing it in the lower
right or upper left part of the concatenated matrix.
- concatenateDiagonally(RealMatrix, boolean, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Diagonally or anti-diagonally concatenates this matrix and another matrix m.
- concatenateDiagonally(RealMatrix, boolean, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Diagonally or anti-diagonally concatenates this matrix and another matrix m.
- concatenateDiagonally(RealMatrix, boolean, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Diagonally or anti-diagonally concatenates this matrix and another matrix m.
- concatenateDiagonally(RealMatrix, boolean, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Diagonally or anti-diagonally concatenates this matrix and another matrix m.
- concatenateDiagonally(RealMatrix) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Diagonally concatenates this matrix and another matrix m, placing it in the lower
right part of the concatenated matrix.
- concatenateDiagonally(RealMatrix, boolean) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Diagonally concatenates this matrix and another matrix m, placing it in the lower
right or upper left part of the concatenated matrix.
- concatenateDiagonally(RealMatrix, boolean, boolean) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Diagonally or anti-diagonally concatenates this matrix and another matrix m.
- concatenateHorizontally(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Horizontally concatenates this matrix and another matrix m, placing it in the right
part of the concatenated matrix.
- concatenateHorizontally(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Horizontally concatenates this matrix and another matrix m, , placing it in the left
or right part of the concatenated matrix.
- concatenateHorizontally(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Horizontally concatenates this matrix and another matrix m, , placing it in the left
or right part of the concatenated matrix.
- concatenateHorizontally(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Horizontally concatenates this matrix and another matrix m, , placing it in the left
or right part of the concatenated matrix.
- concatenateHorizontally(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Horizontally concatenates this matrix and another matrix m, , placing it in the left
or right part of the concatenated matrix.
- concatenateHorizontally(RealMatrix, RealMatrix) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Concatenates two matrices horizontally.
- concatenateHorizontally(RealMatrix) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Horizontally concatenates this matrix and another matrix m, placing it in the right
part of the concatenated matrix.
- concatenateHorizontally(RealMatrix, boolean) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Horizontally concatenates this matrix and another matrix m, , placing it in the left
or right part of the concatenated matrix.
- concatenateParameterDescriptorNames(Collection<ParameterDescriptor>, String, String, boolean) - Static method in class fr.cnes.sirius.patrius.math.parameter.ParameterUtils
-
Concatenates the names of multiple parameter descriptors.
- concatenateParameterNames(Collection<Parameter>, String, String, boolean) - Static method in class fr.cnes.sirius.patrius.math.parameter.ParameterUtils
-
Concatenates the names of multiple parameters.
- concatenateVertically(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Vertically concatenates this matrix and another matrix m, placing it in the lower
part of the concatenated matrix.
- concatenateVertically(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Vertically concatenates this matrix and another matrix m, placing it in the lower or
upper part of the concatenated matrix.
- concatenateVertically(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Vertically concatenates this matrix and another matrix m, placing it in the lower or
upper part of the concatenated matrix.
- concatenateVertically(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Vertically concatenates this matrix and another matrix m, placing it in the lower or
upper part of the concatenated matrix.
- concatenateVertically(RealMatrix, boolean) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Vertically concatenates this matrix and another matrix m, placing it in the lower or
upper part of the concatenated matrix.
- concatenateVertically(RealMatrix, RealMatrix) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Concatenates two matrices vertically.
- concatenateVertically(RealMatrix) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Vertically concatenates this matrix and another matrix m, placing it in the lower
part of the concatenated matrix.
- concatenateVertically(RealMatrix, boolean) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Vertically concatenates this matrix and another matrix m, placing it in the lower or
upper part of the concatenated matrix.
- Cone - Interface in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
This interface extends the solid shape for the particular case of cones.
- conjugate() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Return the conjugate of this complex number.
- ConjugateGradient - Class in fr.cnes.sirius.patrius.math.linear
-
- ConjugateGradient(int, double, boolean) - Constructor for class fr.cnes.sirius.patrius.math.linear.ConjugateGradient
-
- ConjugateGradient(IterationManager, double, boolean) - Constructor for class fr.cnes.sirius.patrius.math.linear.ConjugateGradient
-
- CONST_ONE_ON_EIGHT - Static variable in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Constant.
- CONST_SOL_N_M2 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Solar constant (N/M**2).
- CONST_SOL_STELA - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Solar Constant (N/M**2).
- CONST_SOL_W_M2 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Solar constant (W/M**2).
- CONSTANT - Static variable in class fr.cnes.sirius.patrius.bodies.AbstractIAUCelestialBody
-
Constant model string.
- Constant - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Constant function.
- Constant(double) - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Constant
-
- CONSTANT_MODE - Static variable in class fr.cnes.sirius.patrius.math.random.ValueServer
-
Always return mu
- ConstantAttitudeLaw - Class in fr.cnes.sirius.patrius.attitudes
-
This class handles a constant attitude law.
- ConstantAttitudeLaw(Frame, Rotation) - Constructor for class fr.cnes.sirius.patrius.attitudes.ConstantAttitudeLaw
-
Creates new instance.
- ConstantFunction - Class in fr.cnes.sirius.patrius.math.parameter
-
This class is used to define a constant parameterizable function.
- ConstantFunction(double) - Constructor for class fr.cnes.sirius.patrius.math.parameter.ConstantFunction
-
Constructor of a constant function f = a0 using the input value.
- ConstantFunction(String, double) - Constructor for class fr.cnes.sirius.patrius.math.parameter.ConstantFunction
-
Constructor of a constant function f = a0 using the input value.
- ConstantFunction(Parameter) - Constructor for class fr.cnes.sirius.patrius.math.parameter.ConstantFunction
-
Constructor of a constant function f = a0 using the input parameter.
- ConstantMeteorologicalConditionsProvider - Class in fr.cnes.sirius.patrius.signalpropagation
-
Provides constant meteorological conditions on a given date interval.
- ConstantMeteorologicalConditionsProvider(MeteorologicalConditions) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.ConstantMeteorologicalConditionsProvider
-
Constructor with a default infinite date interval.
- ConstantMeteorologicalConditionsProvider(MeteorologicalConditions, AbsoluteDateInterval) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.ConstantMeteorologicalConditionsProvider
-
Constructor.
- ConstantOrientationAngleLaw - Class in fr.cnes.sirius.patrius.attitudes.orientations
-
This class aims at creating an orientation angle law whose orientation angle is constant.
- ConstantOrientationAngleLaw(double) - Constructor for class fr.cnes.sirius.patrius.attitudes.orientations.ConstantOrientationAngleLaw
-
Constructor
- ConstantOrientationAngleLeg - Class in fr.cnes.sirius.patrius.attitudes.orientations
-
This class aims at creation an orientation angle leg whose orientation angle is constant in its
interval of validity.
- ConstantOrientationAngleLeg(AbsoluteDateInterval, double) - Constructor for class fr.cnes.sirius.patrius.attitudes.orientations.ConstantOrientationAngleLeg
-
Constructor with default nature.
- ConstantOrientationAngleLeg(AbsoluteDateInterval, double, String) - Constructor for class fr.cnes.sirius.patrius.attitudes.orientations.ConstantOrientationAngleLeg
-
Constructor.
- ConstantPVCoordinatesProvider - Class in fr.cnes.sirius.patrius.orbits.pvcoordinates
-
This class implements the
PVCoordinatesProvider to store the position and the velocity of an object and the
frame used for computation.
- ConstantPVCoordinatesProvider(PVCoordinates, Frame) - Constructor for class fr.cnes.sirius.patrius.orbits.pvcoordinates.ConstantPVCoordinatesProvider
-
Simple constructor.
- ConstantPVCoordinatesProvider(Vector3D, Frame) - Constructor for class fr.cnes.sirius.patrius.orbits.pvcoordinates.ConstantPVCoordinatesProvider
-
Builds an instance from the position vector only.
- ConstantRadiusProvider - Class in fr.cnes.sirius.patrius.bodies
-
Implementation for constant radius provider.
- ConstantRadiusProvider(double) - Constructor for class fr.cnes.sirius.patrius.bodies.ConstantRadiusProvider
-
Constructor with constant value.
- Constants - Interface in fr.cnes.sirius.patrius.utils
-
Set of useful physical constants.
- ConstantSolarActivity - Class in fr.cnes.sirius.patrius.forces.atmospheres.solarActivity
-
This class represents constant solar activity
- ConstantSolarActivity(double, double) - Constructor for class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Constructor for constant solar activity
- ConstantSolarActivity(double, double, double) - Constructor for class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Constructor for constant solar activity
- ConstantSpinSlew - Class in fr.cnes.sirius.patrius.attitudes
-
This class represents a constant spin slew.
- ConstantSpinSlew(Attitude, Attitude) - Constructor for class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Constructor for slew with a duration constraint.
- ConstantSpinSlew(Attitude, Attitude, String) - Constructor for class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Constructor for slew with a duration constraint.
- ConstantSpinSlew(Attitude, Attitude, String, Frame) - Constructor for class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Constructor for slew with a duration constraint.
- ConstantSpinSlew(Attitude, Attitude, double, String) - Constructor for class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Constructor for slew with an angular velocity constraint.
- ConstantSpinSlew(Attitude, Attitude, double, String, Frame) - Constructor for class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Constructor for slew with an angular velocity constraint.
- ConstantSpinSlewComputer - Class in fr.cnes.sirius.patrius.attitudes.slew
-
Class for constant spin slew computation with angular velocity constraint.
- ConstantSpinSlewComputer(double) - Constructor for class fr.cnes.sirius.patrius.attitudes.slew.ConstantSpinSlewComputer
-
Builds an instance from an angular velocity constraint.
- ConstantSpinSlewComputer(double, String) - Constructor for class fr.cnes.sirius.patrius.attitudes.slew.ConstantSpinSlewComputer
-
Builds an instance from an angular velocity constraint.
- ConstantThrustError - Class in fr.cnes.sirius.patrius.forces.maneuvers
-
This class is a model of the error of a simple maneuver with constant thrust.
- ConstantThrustError(AbsoluteDate, double, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are parameterizable and differentiable function.
- ConstantThrustError(AbsoluteDate, double, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
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
Errors components are expressed in spacecraft frame.
- ConstantThrustError(AbsoluteDate, double, double, double, double, double, double, double, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
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
Errors components are expressed in spacecraft frame.
- ConstantThrustError(AbsoluteDate, double, Parameter, Parameter, Parameter) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in spacecraft frame.
- ConstantThrustError(AbsoluteDate, double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in spacecraft frame.
- ConstantThrustError(AbsoluteDate, double, Frame, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are parameterizable and differentiable function.
- ConstantThrustError(AbsoluteDate, double, Frame, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
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
Errors components are expressed in provided frame.
- ConstantThrustError(AbsoluteDate, double, Frame, double, double, double, double, double, double, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
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
Errors components are expressed in provided frame.
- ConstantThrustError(AbsoluteDate, double, Frame, Parameter, Parameter, Parameter) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in provided frame.
- ConstantThrustError(AbsoluteDate, double, Frame, double, double, double) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in provided frame.
- ConstantThrustError(AbsoluteDate, double, LOFType, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are parameterizable and differentiable function.
- ConstantThrustError(AbsoluteDate, double, LOFType, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
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
Errors components are expressed in provided local orbital frame.
- ConstantThrustError(AbsoluteDate, double, LOFType, double, double, double, double, double, double, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
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
Errors components are expressed in provided local orbital frame.
- ConstantThrustError(AbsoluteDate, double, LOFType, Parameter, Parameter, Parameter) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in provided local orbital frame.
- ConstantThrustError(AbsoluteDate, double, LOFType, double, double, double) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in provided local orbital frame.
- ConstantThrustError(EventDetector, EventDetector, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in spacecraft frame.
- ConstantThrustError(EventDetector, EventDetector, Parameter, Parameter, Parameter) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in spacecraft frame.
- ConstantThrustError(EventDetector, EventDetector, Frame, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in provided frame.
- ConstantThrustError(EventDetector, EventDetector, Frame, Parameter, Parameter, Parameter) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in provided frame.
- ConstantThrustError(EventDetector, EventDetector, LOFType, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in provided local orbital frame.
- ConstantThrustError(EventDetector, EventDetector, LOFType, Parameter, Parameter, Parameter) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
Errors components are expressed in provided local orbital frame.
- ConstantVectorDirection - Class in fr.cnes.sirius.patrius.attitudes.directions
-
Direction described only by a vector constant in a frame
- ConstantVectorDirection(Vector3D, Frame) - Constructor for class fr.cnes.sirius.patrius.attitudes.directions.ConstantVectorDirection
-
Build a direction from a frame and a vector constant in this frame
- ConstantWallGasTemperature - Class in fr.cnes.sirius.patrius.assembly.models.cook
-
Constant wall gas temperature.
- ConstantWallGasTemperature(double) - Constructor for class fr.cnes.sirius.patrius.assembly.models.cook.ConstantWallGasTemperature
-
Constructor.
- contains(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Check if the instance contains a point.
- contains(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Check if the instance contains a point.
- contains(Vector2D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Check if the line contains a point.
- contains(Region<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Check if the instance entirely contains another region.
- contains(Region<S>) - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Region
-
Check if the instance entirely contains another region.
- contains(double) - Method in class fr.cnes.sirius.patrius.math.interval.AngleInterval
-
Returns true if the angle is contained in this interval, false otherwise.
- contains(Comparable<T>) - Method in class fr.cnes.sirius.patrius.math.interval.ComparableInterval
-
Returns true if the provided value belongs to the interval.
- contains(int[], int) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.util.ArrayUtils
-
Checks if the value is in the given array.
- contains(FieldDescriptor<?>) - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Checks if a field descriptor is currently associated with this parameter descriptor.
- contains(FieldDescriptor<?>, Object) - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Checks if a field descriptor is currently associated with this parameter descriptor and
mapped to a given value.
- contains(Parameter) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Check if the parameter is already in the selectedParameters list
- contains(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.utils.legs.Leg
-
Check whether the given date is contained in the interval of the current leg.
- contains(Object) - Method in interface fr.cnes.sirius.patrius.utils.legs.TimeSequence
- containsAll(Collection<?>) - Method in interface fr.cnes.sirius.patrius.utils.legs.TimeSequence
- containsClass(Class<?>) - Method in class fr.cnes.sirius.patrius.math.util.TransformerMap
-
Tests if a Class is present in the TransformerMap.
- containsData(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Check if the provided date belongs to any available interval.
- containsKey(int) - Method in class fr.cnes.sirius.patrius.math.util.OpenIntToDoubleHashMap
-
Check if a value is associated with a key.
- containsKey(int) - Method in class fr.cnes.sirius.patrius.math.util.OpenIntToFieldHashMap
-
Check if a value is associated with a key.
- containsNaN(double...) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Evaluate if the given values describe at least one
Double.NaN.
- containsSatellite(String) - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
Tests whether a satellite with the given id is contained in this orbit
file.
- containsSatellite(String) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Tests whether a satellite with the given id is contained in this orbit
file.
- containsTransformer(NumberTransformer) - Method in class fr.cnes.sirius.patrius.math.util.TransformerMap
-
Tests if a NumberTransformer is present in the TransformerMap.
- ContinuedFraction - Class in fr.cnes.sirius.patrius.math.util
-
Provides a generic means to evaluate continued fractions.
- ContinuedFraction() - Constructor for class fr.cnes.sirius.patrius.math.util.ContinuedFraction
-
Default constructor.
- ContinuousMSISE2000SolarData - Class in fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized
-
This class represents a solar data container adapted for the
MSISE2000 atmosphere model
This model of input parameters computes averages for ALL the ap values required by the MSISE2000 model.
- ContinuousMSISE2000SolarData(SolarActivityDataProvider) - Constructor for class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.ContinuousMSISE2000SolarData
-
Constructor.
- ContinuousOutputModel - Class in fr.cnes.sirius.patrius.math.ode
-
This class stores all information provided by an ODE integrator
during the integration process and build a continuous model of the
solution from this.
- ContinuousOutputModel() - Constructor for class fr.cnes.sirius.patrius.math.ode.ContinuousOutputModel
-
Simple constructor.
- ContinuousThrustManeuver - Class in fr.cnes.sirius.patrius.forces.maneuvers
-
This class implements a thrust (constant or variable).
- ContinuousThrustManeuver(AbsoluteDate, double, PropulsiveProperty, Vector3D, MassProvider, TankProperty) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a constant direction in satellite frame.
- ContinuousThrustManeuver(AbsoluteDate, double, PropulsiveProperty, IDependentVectorVariable<SpacecraftState>, MassProvider, TankProperty) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a variable direction in satellite frame.
- ContinuousThrustManeuver(AbsoluteDate, double, PropulsiveProperty, Vector3D, MassProvider, TankProperty, Frame) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a constant direction in provided frame.
- ContinuousThrustManeuver(AbsoluteDate, double, PropulsiveProperty, IDependentVectorVariable<SpacecraftState>, MassProvider, TankProperty, Frame) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a variable direction in provided frame.
- ContinuousThrustManeuver(AbsoluteDate, double, PropulsiveProperty, Vector3D, MassProvider, TankProperty, LOFType) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a constant direction in provided local orbital frame.
- ContinuousThrustManeuver(AbsoluteDate, double, PropulsiveProperty, IDependentVectorVariable<SpacecraftState>, MassProvider, TankProperty, LOFType) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a variable direction in provided local orbital frame.
- ContinuousThrustManeuver(EventDetector, EventDetector, PropulsiveProperty, Vector3D, MassProvider, TankProperty) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a constant direction in satellite frame.
- ContinuousThrustManeuver(EventDetector, EventDetector, PropulsiveProperty, IDependentVectorVariable<SpacecraftState>, MassProvider, TankProperty) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a variable direction in satellite frame.
- ContinuousThrustManeuver(EventDetector, EventDetector, PropulsiveProperty, Vector3D, MassProvider, TankProperty, Frame) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a constant direction in provided frame.
- ContinuousThrustManeuver(EventDetector, EventDetector, PropulsiveProperty, IDependentVectorVariable<SpacecraftState>, MassProvider, TankProperty, Frame) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a variable direction in provided frame.
- ContinuousThrustManeuver(EventDetector, EventDetector, PropulsiveProperty, Vector3D, MassProvider, TankProperty, LOFType) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a constant direction in local orbital frame.
- ContinuousThrustManeuver(EventDetector, EventDetector, PropulsiveProperty, IDependentVectorVariable<SpacecraftState>, MassProvider, TankProperty, LOFType) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Constructor for a variable direction in local orbital frame.
- contract() - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Contracts the storage array to the (size of the element set) + 1 - to
avoid a zero length array.
- convention - Variable in class fr.cnes.sirius.patrius.math.utils.AbstractSearchIndex
-
The convention for the definition of intervals.
- converged(int, T, T) - Method in class fr.cnes.sirius.patrius.math.optim.AbstractConvergenceChecker
-
Check if the optimization algorithm has converged.
- converged(int, PAIR, PAIR) - Method in interface fr.cnes.sirius.patrius.math.optim.ConvergenceChecker
-
Check if the optimization algorithm has converged.
- converged(int, T, T) - Method in class fr.cnes.sirius.patrius.math.optim.SimplePointChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- converged(int, PointValuePair, PointValuePair) - Method in class fr.cnes.sirius.patrius.math.optim.SimpleValueChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- converged(int, PointVectorValuePair, PointVectorValuePair) - Method in class fr.cnes.sirius.patrius.math.optim.SimpleVectorValueChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- converged(int, UnivariatePointValuePair, UnivariatePointValuePair) - Method in class fr.cnes.sirius.patrius.math.optim.univariate.SimpleUnivariateValueChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- ConvergenceChecker<PAIR> - Interface in fr.cnes.sirius.patrius.math.optim
-
This interface specifies how to check if an optimization algorithm has
converged.
- ConvergenceException - Exception in fr.cnes.sirius.patrius.math.exception
-
Error thrown when a numerical computation can not be performed because the
numerical result failed to converge to a finite value.
- ConvergenceException() - Constructor for exception fr.cnes.sirius.patrius.math.exception.ConvergenceException
-
Construct the exception.
- ConvergenceException(Localizable, Object...) - Constructor for exception fr.cnes.sirius.patrius.math.exception.ConvergenceException
-
Construct the exception with a specific context and arguments.
- convertFrame(Orbit, Frame) - Method in class fr.cnes.sirius.patrius.propagation.analytical.AbstractLyddanePropagator
-
Convert provided orbit in output frame.
- convertFrame(Orbit, Frame) - Method in class fr.cnes.sirius.patrius.propagation.analytical.LiuMeanOsculatingConverter
-
Convert provided orbit in output frame.
- convertIntoCMAction(EventDetector.Action) - Static method in class fr.cnes.sirius.patrius.events.utils.AdaptedMonoEventDetector
-
Convert Orekit action into Commons-Math action
- convertOrbit(Orbit, Frame) - Method in enum fr.cnes.sirius.patrius.orbits.OrbitType
-
Convert an orbit from a given orbit type to an other in a wished frame.
- convertParameterDescriptors(Collection<ParameterDescriptor>, OrbitType, PositionAngle) - Static method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Returns an updated list of parameter descriptors where the orbital coordinates mapped to the
orbital coordinate descriptors were
all converted to the specified orbit type and position angle type.
- convertRadiativePressureToFlux(double, double) - Static method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Get the solar flux (SF) from the solar radiation pressure: SF = pRef * dRef2
- convertTo(OrbitType, PositionAngle) - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.OrbitalCoordinate
-
Gets the coordinate type associated with the same state vector index in a given orbit type
and position angle type.
- convertToComplex(double[]) - Static method in class fr.cnes.sirius.patrius.math.complex.ComplexUtils
-
Convert an array of primitive doubles to an array of Complex objects.
- convertType(Orbit) - Method in enum fr.cnes.sirius.patrius.orbits.OrbitType
-
Convert an orbit to the instance type.
- ConvexMultivariateRealFunction - Interface in fr.cnes.sirius.patrius.math.optim.joptimizer.functions
-
Interface for convex multi-variate real functions.
- CookWallGasTemperature - Class in fr.cnes.sirius.patrius.assembly.models.cook
-
Wall gas temperature following Cook model.
- CookWallGasTemperature(ExtendedAtmosphere, AlphaProvider, double) - Constructor for class fr.cnes.sirius.patrius.assembly.models.cook.CookWallGasTemperature
-
Constructor.
- copy(Assembly) - Method in class fr.cnes.sirius.patrius.assembly.models.AeroModel
-
Copy drag sensitive object using new assembly.
- copy(Assembly) - Method in class fr.cnes.sirius.patrius.assembly.models.DragLiftModel
-
Copy drag sensitive object using new assembly.
- copy(Assembly) - Method in class fr.cnes.sirius.patrius.assembly.models.GlobalAeroModel
-
Copy drag sensitive object using new assembly.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeLawLeg
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in interface fr.cnes.sirius.patrius.attitudes.AttitudeLeg
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.ConstantOrientationAngleLeg
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLawLeg
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in interface fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLeg
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLegsSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLegsSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in interface fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfile
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfileSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfileSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesHarmonicProfile
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfileLeg
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialSlew
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialSlew
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in interface fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfile
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfilesSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfilesSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialProfile
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialProfile
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.RelativeTabulatedAttitudeLeg
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in interface fr.cnes.sirius.patrius.attitudes.Slew
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.StrictAttitudeLegsSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.StrictAttitudeLegsSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Creates a new leg from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedSlew
-
Creates a new leg from this one.
- copy() - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
- copy() - Method in class fr.cnes.sirius.patrius.covariance.MultiOrbitalCovariance
-
Gets a copy of this orbital covariance.
- copy() - Method in class fr.cnes.sirius.patrius.covariance.OrbitalCovariance
-
Gets a copy of this orbital covariance.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.AlignmentDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.AltitudeDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.AngularMomentumExcessDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.AnomalyDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.AOLDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ApparentElevationDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ApsideDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.BetaAngleDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.BodyInEclipseDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.BodyPointLocalTimeAngleDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.CenteredAolPassageDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.CentralBodyMaskCircularFOVDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.CircularFieldOfViewDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.CombinedPhenomenaDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.DateDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.DihedralFieldOfViewDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.DistanceDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.DotProductDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.EarthZoneDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.EclipseDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ElevationDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaDistanceDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaElevationDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaGenericDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaLatitudeDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaLongitudeDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaSightAxisDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaThreeBodiesAngleDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.FlightDomainExcessDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.GroundMaskElevationDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.LatitudeDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.LineMaskingDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.LocalTimeAngleDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.LongitudeDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.MaskingDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.NadirSolarIncidenceDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.NodeDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.NullMassDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.NullMassPartDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.PlaneCrossingDetector
-
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.RelativeDateDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.RFVisibilityDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.TargetInFieldOfViewDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.detectors.VisibilityFromStationDetector
-
A copy of the detector.
- copy() - Method in interface fr.cnes.sirius.patrius.events.EventDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.utils.EventShifter
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
A copy of the atmosphere.
- copy() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.Atmosphere
-
A copy of the atmosphere.
- copy() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.DTM2000
-
A copy of the atmosphere.
- copy() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.DTM2012
-
A copy of the atmosphere.
- copy() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.HarrisPriester
-
A copy of the atmosphere.
- copy() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.JB2006
-
A copy of the atmosphere.
- copy() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
A copy of the atmosphere.
- copy() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
A copy of the atmosphere.
- copy() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.US76
-
A copy of the atmosphere.
- copy(Assembly) - Method in interface fr.cnes.sirius.patrius.forces.drag.DragSensitive
-
Copy drag sensitive object using new assembly.
- copy() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Copies this function and returns a new one identical to this.
- copy(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Build a new date polynomial function whose value over time is the same as this (same degree), only the origin
date is different what may modify the time factor and/or the polynomial coefficients (pending the polynomial
type).
- copy(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunction
-
Build a new date polynomial function whose value over time is the same as this (same degree), only the origin
date is different what may modify the time factor and/or the polynomial coefficients (pending the polynomial
type).
- copy(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunctionInterface
-
Build a new date polynomial function whose value over time is the same as this (same degree), only the origin
date is different what may modify the time factor and/or the polynomial coefficients (pending the polynomial
type).
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Returns a (deep) copy of this.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Returns a (deep) copy of this vector.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in interface fr.cnes.sirius.patrius.math.linear.FieldVector
-
Returns a (deep) copy of this.
- copy() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Returns a (deep) copy of this vector.
- copy() - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricPositiveMatrix
-
Returns a deep copy of this matrix.
- copy() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Copy the instance.
- copy() - Method in interface fr.cnes.sirius.patrius.math.ode.sampling.StepInterpolator
-
Copy the instance.
- copy() - Method in class fr.cnes.sirius.patrius.math.parameter.Parameter
-
Performs a shallow copy of this parameter (the references to the field descriptors and the
mapped values are preserved).
- copy() - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Performs a shallow copy of the parameter descriptor (the references to the field descriptors
and the mapped values are preserved).
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AbstractUnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns a copy of this DescriptiveStatistics instance with the same internal state.
- copy(DescriptiveStatistics, DescriptiveStatistics) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Returns a copy of the statistic with the same internal state.
- copy(GeometricMean, GeometricMean) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Kurtosis
-
Returns a copy of the statistic with the same internal state.
- copy(Kurtosis, Kurtosis) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Kurtosis
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Mean
-
Returns a copy of the statistic with the same internal state.
- copy(Mean, Mean) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Mean
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SecondMoment
-
Returns a copy of the statistic with the same internal state.
- copy(SecondMoment, SecondMoment) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SecondMoment
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Returns a copy of the statistic with the same internal state.
- copy(SemiVariance, SemiVariance) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Skewness
-
Returns a copy of the statistic with the same internal state.
- copy(Skewness, Skewness) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Skewness
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Returns a copy of the statistic with the same internal state.
- copy(StandardDeviation, StandardDeviation) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Variance
-
Returns a copy of the statistic with the same internal state.
- copy(Variance, Variance) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Variance
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Max
-
Returns a copy of the statistic with the same internal state.
- copy(Max, Max) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Max
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Min
-
Returns a copy of the statistic with the same internal state.
- copy(Min, Min) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Min
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Percentile
-
Returns a copy of the statistic with the same internal state.
- copy(Percentile, Percentile) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Percentile
-
Copies source to dest.
- copy() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StorelessUnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Product
-
Returns a copy of the statistic with the same internal state.
- copy(Product, Product) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Product
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Sum
-
Returns a copy of the statistic with the same internal state.
- copy(Sum, Sum) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Sum
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfLogs
-
Returns a copy of the statistic with the same internal state.
- copy(SumOfLogs, SumOfLogs) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfLogs
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfSquares
-
Returns a copy of the statistic with the same internal state.
- copy(SumOfSquares, SumOfSquares) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfSquares
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns a copy of this SummaryStatistics instance with the same internal state.
- copy(SummaryStatistics, SummaryStatistics) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns a copy of this SynchronizedDescriptiveStatistics instance with the
same internal state.
- copy(SynchronizedDescriptiveStatistics, SynchronizedDescriptiveStatistics) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Copies source to dest.
- copy() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns a copy of this SynchronizedSummaryStatistics instance with the
same internal state.
- copy(SynchronizedSummaryStatistics, SynchronizedSummaryStatistics) - Static method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Copies source to dest.
- copy() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.UnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy(ResizableDoubleArray, ResizableDoubleArray) - Static method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Copies source to dest, copying the underlying data, so dest is a new, independent copy of source.
- copy() - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Returns a copy of the ResizableDoubleArray.
- copy() - Method in class fr.cnes.sirius.patrius.propagation.sampling.AdaptedStepHandler
-
Copy this.
- copy() - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
-
Copy this.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
A copy of the atmosphere.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.AbstractStelaDragCoef
-
Copy drag coefficient.
- copy(Assembly) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAeroModel
-
Copy drag sensitive object using new assembly.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaConstantDragCoef
-
Copy drag coefficient.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDispersedDragCoef
-
Copy drag coefficient.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDragCoef
-
Copy drag coefficient.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDispersedDragCoef
-
Copy drag coefficient.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoef
-
Copy drag coefficient.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaConstantSolarActivity
-
Copy the solar activity model.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaLOSConstantSolarActivity
-
Copy the solar activity model.
- copy() - Method in interface fr.cnes.sirius.patrius.stela.forces.solaractivity.IStelaSolarActivity
-
Copy the solar activity model.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.Stela3StepsSolarActivity
-
Copy the solar activity model.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivity
-
Copy the solar activity model.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableDispersedSolarActivity
-
Copy the solar activity model.
- copy() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Copy the solar activity model.
- copy() - Method in class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
-
A copy of the detector.
- copy() - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Copy space object.
- copy(AbsoluteDateInterval) - Method in interface fr.cnes.sirius.patrius.utils.legs.Leg
-
Creates a new leg from this one.
- copy() - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Returns a copy of the sequence.
- copy(AbsoluteDateInterval, boolean) - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Creates a new legs sequence from this one.
- copy() - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Returns a copy of the sequence.
- copy(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Creates a new legs sequence from this one.
- copy(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Creates a new legs sequence from this one.
- copy() - Method in interface fr.cnes.sirius.patrius.utils.legs.TimeSequence
-
Returns a copy of the sequence.
- copyArray(double[][]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Returns a deep copy of a 2D double array.
- copyOf(int[]) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Creates a copy of the source array.
- copyOf(double[]) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Creates a copy of the source array.
- copyOf(int[], int) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Creates a copy of the source array.
- copyOf(double[], int) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Creates a copy of the source array.
- copySelf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.OrientedPoint
-
Copy the instance.
- copySelf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Copy the instance.
- copySelf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Copy the instance.
- copySelf() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Copy the instance.
- copySelf() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractSubHyperplane
-
Copy the instance.
- copySelf() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BSPTree
-
Copy the instance.
- copySelf() - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Hyperplane
-
Copy the instance.
- copySelf() - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Region
-
Copy the instance.
- copySelf() - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.SubHyperplane
-
Copy the instance.
- copySign(DerivativeStructure) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Returns the instance with the sign of the argument.
- copysign(Dfp, Dfp) - Static method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Creates an instance that is the same as x except that it has the sign of y.
- copySign(double, double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(double, double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(double, double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(double, double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(double, double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Returns the first argument with the sign of the second argument.
- copySign(double, double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(double, double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Returns the first argument with the sign of the second argument.
- copySign(T) - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Returns the instance with the sign of the argument.
- copySign(double, double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySign(double, double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Returns the first argument with the sign of the second argument.
- copySign(byte, byte) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySign(int, int) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySign(long, long) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySubMatrix(int, int, int, int, T[][]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], T[][]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, double[][]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Copies a submatrix into a given 2D array.
- copySubMatrix(int, int, int, int, double[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Copies a submatrix into a given 2D array.
- copySubMatrix(int[], int[], double[][]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Copies a submatrix into a given 2D array.
- copySubMatrix(int[], int[], double[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Copies a submatrix into a given 2D array.
- copySubMatrix(int, int, int, int, double[][]) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Copies a submatrix into a given 2D array.
- copySubMatrix(int[], int[], double[][]) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Copies a submatrix into a given 2D array.
- copySubMatrix(int, int, int, int, T[][]) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], T[][]) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, double[][]) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Copies a submatrix into a given 2D array.
- copySubMatrix(int, int, int, int, double[][], int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Copies a submatrix into a given 2D array.
- copySubMatrix(int[], int[], double[][]) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Copies a submatrix into a given 2D array.
- copySubMatrix(int[], int[], double[][], int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Copies a submatrix into a given 2D array.
- CoriolisRelativisticEffect - Class in fr.cnes.sirius.patrius.forces.relativistic
-
Computation of the relativistic Coriolis effect (Einstein-de-Sitter effect)
- IERS2003 standard (applies to Earth only).
- CoriolisRelativisticEffect(double, PVCoordinatesProvider) - Constructor for class fr.cnes.sirius.patrius.forces.relativistic.CoriolisRelativisticEffect
-
Constructor with partial derivative computation by default.
- CoriolisRelativisticEffect(double, PVCoordinatesProvider, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.relativistic.CoriolisRelativisticEffect
-
Constructor.
- correct(double[]) - Method in class fr.cnes.sirius.patrius.math.filter.KalmanFilter
-
Correct the current state estimate with an actual measurement.
- correct(RealVector) - Method in class fr.cnes.sirius.patrius.math.filter.KalmanFilter
-
Correct the current state estimate with an actual measurement.
- correctInclination(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Inclination correction because of inclination singularity in StelaEquinoctial parameters
around 180deg.
- CorrelatedRandomVectorGenerator - Class in fr.cnes.sirius.patrius.math.random
-
- CorrelatedRandomVectorGenerator(double[], RealMatrix, double, NormalizedRandomGenerator) - Constructor for class fr.cnes.sirius.patrius.math.random.CorrelatedRandomVectorGenerator
-
Builds a correlated random vector generator from its mean
vector and covariance matrix.
- CorrelatedRandomVectorGenerator(RealMatrix, double, NormalizedRandomGenerator) - Constructor for class fr.cnes.sirius.patrius.math.random.CorrelatedRandomVectorGenerator
-
Builds a null mean random correlated vector generator from its
covariance matrix.
- correlation(double[], double[]) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.PearsonsCorrelation
-
Computes the Pearson's product-moment correlation coefficient between the two arrays.
- correlation(double[], double[]) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation coefficient between the two arrays.
- cos() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Cosine operation.
- cos(double[], int, double[], int) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Compute cosine of a derivative structure.
- Cos - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Cosine function.
- Cos() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Cos
-
- cos() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Compute the
cosine
of this complex number.
- cos(Dfp) - Static method in class fr.cnes.sirius.patrius.math.dfp.DfpMath
-
computes the cosine of the argument.
- cos(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Cosine function.
- cos(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Cosine function.
- cos(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Cosine function.
- cos(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Cosine function.
- cos(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Cosine function.
- cos(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Cosine function.
- cos(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Cosine function.
- cos() - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Cosine operation.
- cos(double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Cosine function.
- cos(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Cosine function.
- cosh() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Hyperbolic cosine operation.
- cosh(double[], int, double[], int) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Compute hyperbolic cosine of a derivative structure.
- Cosh - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Hyperbolic cosine function.
- Cosh() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Cosh
-
- cosh() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
- cosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Compute the hyperbolic cosine of a number.
- cosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Compute the hyperbolic cosine of a number.
- cosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Compute the hyperbolic cosine of a number.
- cosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Compute the hyperbolic cosine of a number.
- cosh(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Compute the hyperbolic cosine of a number.
- cosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Compute the hyperbolic cosine of a number.
- cosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Compute the hyperbolic cosine of a number.
- cosh() - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Hyperbolic cosine operation.
- cosh(double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Compute the hyperbolic cosine of a number.
- cosh(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Compute the hyperbolic cosine of a number.
- cosi0 - Variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
cosinus original inclination.
- cosine(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Computes the cosine of the angle between this vector and the
argument.
- CosineFunction - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Cosine function of the form c.cos(f(x)) with f an univariate function that returns an angle in radians.
- CosineFunction(double, UnivariateDifferentiableFunction) - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.CosineFunction
-
Constructor.
- CounterArray - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
This class class defines the object CounterArray and all the methods to manipulate it.
- CounterArray(String) - Constructor for class fr.cnes.sirius.patrius.bodies.bsp.spice.CounterArray
-
Initializes the counter taking into account if it is a subsystem counter
or an user counter.
- Covariance - Class in fr.cnes.sirius.patrius.covariance
-
Covariance representation.
- Covariance(SymmetricPositiveMatrix) - Constructor for class fr.cnes.sirius.patrius.covariance.Covariance
-
Creates a new instance using the specified covariance matrix.
- Covariance(SymmetricPositiveMatrix, Collection<ParameterDescriptor>) - Constructor for class fr.cnes.sirius.patrius.covariance.Covariance
-
Creates a new instance using the specified covariance matrix and parameter descriptors.
- Covariance - Class in fr.cnes.sirius.patrius.math.stat.correlation
-
Computes covariances for pairs of arrays or columns of a matrix.
- Covariance() - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Create a Covariance with no data
- Covariance(double[][], boolean) - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Create a Covariance matrix from a rectangular array
whose columns represent covariates.
- Covariance(double[][]) - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Create a Covariance matrix from a rectangular array
whose columns represent covariates.
- Covariance(RealMatrix, boolean) - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns
represent covariates.
- Covariance(RealMatrix) - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns
represent covariates.
- covariance(double[], double[], boolean) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Computes the covariance between the two arrays.
- covariance(double[], double[]) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Computes the covariance between the two arrays, using the bias-corrected
formula.
- CovarianceInterpolation - Class in fr.cnes.sirius.patrius.propagation.analytical.covariance
-
This class allows the interpolation of a covariance matrix at a date t in [t1, t2]
using the surrounding covariances matrices Covt1 Covt2.
- CovarianceInterpolation(AbsoluteDate, RealMatrix, AbsoluteDate, RealMatrix, int, Orbit, double) - Constructor for class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
Constructor of the class CovarianceInterpolation
- CovarianceInterpolation(AbsoluteDate, double[][], AbsoluteDate, double[][], int, Orbit, double) - Constructor for class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
Constructor of the class CovarianceInterpolation
- covarianceToCorrelation(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.PearsonsCorrelation
-
Derives a correlation matrix from a covariance matrix.
- CowellIntegrator - Class in fr.cnes.sirius.patrius.math.ode.nonstiff.cowell
-
This class implements a 2nd order Cowell integrator.
- CowellIntegrator(int, double, double) - Constructor for class fr.cnes.sirius.patrius.math.ode.nonstiff.cowell.CowellIntegrator
-
Constructor.
- CPMG - Static variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Cosine of the latitude of the magnetic pole (79N, 71W).
- create(RealLinearOperator) - Static method in class fr.cnes.sirius.patrius.math.linear.JacobiPreconditioner
-
Creates a new instance of this class.
- createAdaptor(RandomGenerator) - Static method in class fr.cnes.sirius.patrius.math.random.RandomAdaptor
-
Factory method to create a Random using the supplied RandomGenerator.
- createAssembly(Frame) - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
- createAssembly(Frame, double, double, double) - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
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.
- createBlocksLayout(Field<T>, int, int) - Static method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Create a data array in blocks layout.
- createBlocksLayout(int, int) - Static method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Create a data array in blocks layout.
- createChebyshevPolynomial(int) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialsUtils
-
Create a Chebyshev polynomial of the first kind.
- createCircle(int, double) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.functions.FunctionsUtils
-
Create a circle
- createCircle(int, double, double[]) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.functions.FunctionsUtils
-
Create a circle
- createColumnFieldMatrix(T[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Creates a column
FieldMatrix using the data from the input array.
- createColumnRealMatrix(double[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Creates a column
RealMatrix using the data from the input array.
- createComplex(double, double) - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Create a complex number given the real and imaginary parts.
- createComplexArray(double[][]) - Static method in class fr.cnes.sirius.patrius.math.transform.TransformUtils
-
Builds a new array of
Complex from the specified two dimensional
array of real and imaginary parts.
- createComponents(double[], double[][], double[][][]) - Static method in class fr.cnes.sirius.patrius.math.distribution.MixtureMultivariateNormalDistribution
-
Creates a mixture of Gaussian distributions.
- createConstant(double) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Create a constant compatible with instance order and number of parameters.
- createContributingStatistics() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Creates and returns a SummaryStatistics whose data will be
aggregated with those of this AggregateSummaryStatistics.
- createDiagonalArray(int, double) - Static method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
Creates a diagonal square matrix of dimension dim equals to coef * identity (dim)
- createDiagonalMatrix(int, double) - Static method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
Creates a diagonal square matrix of dimension dim equals to coef * identity (dim)
- createFieldDiagonalMatrix(T[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Returns a diagonal matrix with specified elements.
- createFieldIdentityMatrix(Field<T>, int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Returns dimension x dimension identity matrix.
- createFieldMatrix(Field<T>, int, int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
- createFieldMatrix(T[][]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Returns a
FieldMatrix whose entries are the the values in the the input array.
- createFieldVector(T[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Creates a
FieldVector using the data from the input array.
- createFromModifiedRodrigues(double[][], boolean) - Static method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Convert a modified Rodrigues vector and derivatives to angular coordinates.
- createFromModifiedRodrigues(double[][]) - Static method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Convert a modified Rodrigues vector and derivatives to angular coordinates.
- createFromWeekComponents(int, int, int) - Static method in class fr.cnes.sirius.patrius.time.DateComponents
-
Build a date from week components.
- createGPSDate(int, double) - Static method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Build an instance corresponding to a GPS date.
- createHermitePolynomial(int) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialsUtils
-
Create a Hermite polynomial.
- createIdentityMatrix(int) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Creates an identity matrix of the specified dimension.
- createIdentityMatrix(int) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Creates an identity matrix of the specified dimension.
- createIdentityMatrix(int) - Static method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Creates an identity matrix of the specified dimension.
- createIdentityMatrix(int) - Static method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Creates an identity matrix of the specified dimension.
- createIllegalArgumentException(Localizable, Object...) - Static method in exception fr.cnes.sirius.patrius.utils.exception.PatriusException
-
- createIllegalStateException(Localizable, Object...) - Static method in exception fr.cnes.sirius.patrius.utils.exception.PatriusException
-
- createInternalError(Throwable) - Static method in exception fr.cnes.sirius.patrius.utils.exception.PatriusException
-
- createInverseJacobian(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Create an inverse Jacobian.
- createJacobiPolynomial(int, int, int) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialsUtils
-
Create a Jacobi polynomial.
- createLaguerrePolynomial(int) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialsUtils
-
Create a Laguerre polynomial.
- createLegendrePolynomial(int) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialsUtils
-
Create a Legendre polynomial.
- createLine(Vector3D, Vector3D) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Creates a Line object from a point of space and a direction vector.
- createLine(Vector3D, Vector3D, Vector3D) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Creates a Line object from a point of space, a direction vector and the point of minimum abscissa.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Creates a new matrix of the same type as this matrix.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Creates a new matrix of the same type as this matrix.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Creates a new matrix of the same type as this matrix.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Creates a new matrix of the same type as this matrix.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Creates a new matrix of the same type as this matrix.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Creates a new matrix of the same type as this matrix.
- createMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Creates a new matrix of the same type as this matrix.
- createMatrix(int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Creates a new matrix of the same type as this matrix.
- createMatrix(int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Creates a new matrix of the same type as this matrix.
- createMatrix(int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricPositiveMatrix
-
Creates a new matrix of the same type as this matrix.
- createParseException(Localizable, Object...) - Static method in exception fr.cnes.sirius.patrius.utils.exception.PatriusException
-
- createPhase1BarrierFunction() - Method in interface fr.cnes.sirius.patrius.math.optim.joptimizer.functions.BarrierFunction
-
Create the barrier function for the basic Phase I method.
- createPhase1BarrierFunction() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.functions.LogarithmicBarrier
-
Create the barrier function for the Phase I.
- createRealDiagonalMatrix(double[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Returns a diagonal matrix with specified elements.
- createRealIdentityMatrix(int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Returns dimension x dimension identity matrix.
- createRealIdentityMatrix(int, boolean) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Returns dimension x dimension identity matrix.
- createRealImaginaryArray(Complex[]) - Static method in class fr.cnes.sirius.patrius.math.transform.TransformUtils
-
Builds a new two dimensional array of
double filled with the real
and imaginary parts of the specified
Complex numbers.
- createRealMatrix(int, int) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
- createRealMatrix(double[][]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Returns a
RealMatrix whose entries are the the values in the the input array.
- createRealMatrix(double[][], boolean) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Returns a
RealMatrix whose entries are the the values in the the input array.
- createRealVector(double[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Creates a
RealVector using the data from the input array.
- createRowFieldMatrix(T[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Create a row
FieldMatrix using the data from the input array.
- createRowRealMatrix(double[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Create a row
RealMatrix using the data from the input array.
- createStelaCompatibleSpacecraft(String, double, double, double, double, double) - Static method in class fr.cnes.sirius.patrius.stela.StelaSpacecraftFactory
-
Utility method to create a STELA Assembly, made of a sphere with both radiative and aerodynamic properties.
- createStelaRadiativeSpacecraft(String, double, double, double) - Static method in class fr.cnes.sirius.patrius.stela.StelaSpacecraftFactory
-
Utility method to create a STELA Assembly, made of a sphere with only radiative properties.
- CRITICAL_PROGRADE_INCLINATION - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Critical prograde inclination from 4 - 5 × sin2i = 0
see "Fundamentals of Astrodynamics and Applications", 3rd Edition, D.
- CRITICAL_RETROGRADE_INCLINATION - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Critical retrograde inclination from 4 - 5 × sin2i = 0
see "Fundamentals of Astrodynamics and Applications", 3rd Edition, D.
- crossover(Chromosome, Chromosome) - Method in interface fr.cnes.sirius.patrius.math.genetics.CrossoverPolicy
-
Perform a crossover operation on the given chromosomes.
- crossover(Chromosome, Chromosome) - Method in class fr.cnes.sirius.patrius.math.genetics.CycleCrossover
-
Perform a crossover operation on the given chromosomes.
- crossover(Chromosome, Chromosome) - Method in class fr.cnes.sirius.patrius.math.genetics.NPointCrossover
-
Performs a N-point crossover.
- crossover(Chromosome, Chromosome) - Method in class fr.cnes.sirius.patrius.math.genetics.OnePointCrossover
-
Performs one point crossover.
- crossover(Chromosome, Chromosome) - Method in class fr.cnes.sirius.patrius.math.genetics.OrderedCrossover
-
Perform a crossover operation on the given chromosomes.
- crossover(Chromosome, Chromosome) - Method in class fr.cnes.sirius.patrius.math.genetics.UniformCrossover
-
Perform a crossover operation on the given chromosomes.
- CrossoverPolicy - Interface in fr.cnes.sirius.patrius.math.genetics
-
Policy used to create a pair of new chromosomes by performing a crossover
operation on a source pair of chromosomes.
- crossProduct(FieldVector3D<T>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of the instance with another vector.
- crossProduct(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of the instance with another vector.
- crossProduct(FieldVector3D<T>, FieldVector3D<T>) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of two vectors.
- crossProduct(FieldVector3D<T>, Vector3D) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of two vectors.
- crossProduct(Vector3D, FieldVector3D<T>) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of two vectors.
- crossProduct(Vector<Euclidean3D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Compute the cross-product of the instance with another vector.
- crossProduct(Vector3D, Vector3D) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Compute the cross-product of two vectors.
- crossProduct(PVCoordinates, PVCoordinates) - Static method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.PVCoordinates
-
Compute the cross-product of two instances.
- CrossProductDirection - Class in fr.cnes.sirius.patrius.attitudes.directions
-
This direction is the cross product of two directions
- CrossProductDirection(IDirection, IDirection) - Constructor for class fr.cnes.sirius.patrius.attitudes.directions.CrossProductDirection
-
Build a cross product of two directions.
- CrossSectionProvider - Interface in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
Interface for all geometric objects that can provide their cross section from a direction defined by a Vector3D.
- CrossSectionProviderProperty - Class in fr.cnes.sirius.patrius.assembly.properties
-
This class is a part property for the PATRIUS assembly.
- CrossSectionProviderProperty(CrossSectionProvider) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.CrossSectionProviderProperty
-
Constructor of this property.
- CtCookModel - Class in fr.cnes.sirius.patrius.assembly.models.cook
-
This class implements Cook tangential coefficient to a facet.
- CtCookModel(ExtendedAtmosphere, Facet, Frame, double) - Constructor for class fr.cnes.sirius.patrius.assembly.models.cook.CtCookModel
-
Constructor.
- CTRSIZ - Static variable in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceCommon
-
Size of counter arrays.
- cumulativeProbability(int, int) - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractIntegerDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(x0 < X <= x1).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.BetaDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(int) - Method in class fr.cnes.sirius.patrius.math.distribution.BinomialDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.ExponentialDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.FDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(int) - Method in class fr.cnes.sirius.patrius.math.distribution.HypergeometricDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(int) - Method in interface fr.cnes.sirius.patrius.math.distribution.IntegerDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(int, int) - Method in interface fr.cnes.sirius.patrius.math.distribution.IntegerDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(x0 < X <= x1).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.LogNormalDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.NormalDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(int) - Method in class fr.cnes.sirius.patrius.math.distribution.PascalDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(int) - Method in class fr.cnes.sirius.patrius.math.distribution.PoissonDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in interface fr.cnes.sirius.patrius.math.distribution.RealDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.TDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.TriangularDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(int) - Method in class fr.cnes.sirius.patrius.math.distribution.UniformIntegerDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.UniformRealDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(int) - Method in class fr.cnes.sirius.patrius.math.distribution.ZipfDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- cumulativeProbability(double) - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
For a random variable X whose values are distributed according
to this distribution, this method returns P(X <= x).
- CunninghamGravityModel - Class in fr.cnes.sirius.patrius.forces.gravity
-
This class represents the gravitational field of a celestial body.
- CunninghamGravityModel(Frame, double, double, double[][], double[][]) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
Creates a new instance.
- CunninghamGravityModel(Frame, double, double, double[][], double[][], int, int) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
Creates a new instance.
- CunninghamGravityModel(Frame, Parameter, Parameter, double[][], double[][]) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
- CunninghamGravityModel(Frame, Parameter, Parameter, double[][], double[][], int, int) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
- CunninghamGravityModel(Frame, Parameter, Parameter, double[][], double[][], int, int, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
- current(TimeStamped) - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Returns the current leg at the given date.
- current(TimeStamped) - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Returns the current leg at the given date.
- currentState - Variable in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
current state
- CurveFitter<T extends ParametricUnivariateFunction> - Class in fr.cnes.sirius.patrius.math.fitting
-
Fitter for parametric univariate real functions y = f(x).
- CurveFitter(MultivariateVectorOptimizer) - Constructor for class fr.cnes.sirius.patrius.math.fitting.CurveFitter
-
Simple constructor.
- CX_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
X-component of the C coefficient.
- CY_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Y-component of the C coefficient.
- CycleCrossover<T> - Class in fr.cnes.sirius.patrius.math.genetics
-
Cycle Crossover [CX] builds offspring from ordered chromosomes by identifying cycles
between two parent chromosomes.
- CycleCrossover() - Constructor for class fr.cnes.sirius.patrius.math.genetics.CycleCrossover
-
- CycleCrossover(boolean) - Constructor for class fr.cnes.sirius.patrius.math.genetics.CycleCrossover
-
Creates a new
CycleCrossover policy using the given
randomStart behavior.
- Cylinder - Interface in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
This interface extends the solid shape for the particular case of cylinders.
- CZ_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Z-component of the C coefficient.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractStationToSatDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AlignmentDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AltitudeDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AngularMomentumExcessDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AnomalyDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AOLDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ApparentElevationDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ApsideDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.BetaAngleDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.BodyInEclipseDetector
-
Compute the value of the switching function.
- g(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.detectors.BodyInEclipseDetector
-
Compute the value of the switching function at a given date.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.CenteredAolPassageDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.CentralBodyMaskCircularFOVDetector
-
The switching function is the minimum value between the eclipse detector g function and the
circularFOVDetector
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.CircularFieldOfViewDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.CombinedPhenomenaDetector
-
Compute the value of the switching function for a combination (AND or OR) of two phenomena.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.DateDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.DihedralFieldOfViewDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.DistanceDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.DotProductDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.EarthZoneDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.EclipseDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ElevationDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaDistanceDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaElevationDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaGenericDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaLatitudeDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaLongitudeDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaSightAxisDetector
-
The switching function is specific case of the extrema three bodies angle detector.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaThreeBodiesAngleDetector
-
Compute the value of the switching function.
- g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaThreeBodiesAngleDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.FlightDomainExcessDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.GroundMaskElevationDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.LatitudeDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.LineMaskingDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.LocalTimeAngleDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.LongitudeDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.MaskingDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.NadirSolarIncidenceDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.NullMassDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.NullMassPartDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.PlaneCrossingDetector
-
Event detection function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.RFVisibilityDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Compute the value of the switching function.
- g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.TargetInFieldOfViewDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
Compute the value of the switching function.
- g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.VisibilityFromStationDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.events.EventDetector
-
Compute the value of the switching function.
- g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.MultiAbstractDetector
-
Compute the value of the switching function.
- g(Map<String, SpacecraftState>) - Method in interface fr.cnes.sirius.patrius.events.MultiEventDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
Compute the value of the switching function.
- g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiGenericCodingEventDetector
-
Compute the value of the switching function.
- g(double, double[]) - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedEventDetector
-
Compute the value of the switching function.
- g(double, double[]) - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedMonoEventDetector
-
Compute the value of the switching function.
- g(double, double[]) - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedMultiEventDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.utils.EventShifter
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.utils.OneSatEventDetectorWrapper
-
Compute the value of the switching function.
- g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.utils.OneSatEventDetectorWrapper
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Compute the value of the switching function.
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Compute the value of the switching function.
- g(double, double[]) - Method in interface fr.cnes.sirius.patrius.math.ode.events.EventHandler
-
Compute the value of the switching function.
- g - Variable in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Vector g
- g(double[], long[]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.GTest
-
- g(double[], long[]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
-
Compute the value of the switching function.
- G0_STANDARD_GRAVITY - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Standard gravity constant, used in maneuvers definition: 9.80665 m/s2.
- G50Provider - Class in fr.cnes.sirius.patrius.frames.transformations
-
G50 (Gamma 50) frame.
- G50Provider() - Constructor for class fr.cnes.sirius.patrius.frames.transformations.G50Provider
-
- GALILEO_EPOCH - Static variable in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Reference epoch for Galileo System Time: 1999-08-21T23:59:47 UTC.
- GALILEO_EPOCH - Static variable in class fr.cnes.sirius.patrius.time.DateComponents
-
Reference epoch for Galileo System Time: 1999-08-22.
- GalileoScale - Class in fr.cnes.sirius.patrius.time
-
Galileo system time scale.
- Gamma - Class in fr.cnes.sirius.patrius.math.special
-
This is a utility class that provides computation methods related to the Γ (Gamma) family of functions.
- gamma(double) - Static method in class fr.cnes.sirius.patrius.math.special.Gamma
-
Returns the value of Γ(x).
- GAMMA_CST - Static variable in class fr.cnes.sirius.patrius.math.special.Gamma
-
- GammaDistribution - Class in fr.cnes.sirius.patrius.math.distribution
-
Implementation of the Gamma distribution.
- GammaDistribution(double, double) - Constructor for class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Creates a new gamma distribution with specified values of the shape and
scale parameters.
- GammaDistribution(double, double, double) - Constructor for class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Creates a new gamma distribution with specified values of the shape and
scale parameters.
- GammaDistribution(RandomGenerator, double, double, double) - Constructor for class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Creates a Gamma distribution.
- GatesModel - Class in fr.cnes.sirius.patrius.forces.maneuvers
-
This class implements a variation of the model proposed by C.R.
- GatesModel(double, double) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.GatesModel
-
Constructor.
- gaussForcesYDot(double[], StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaDifferentialEquations
-
Compute the contribution of all Gauss forces.
- Gaussian - Class in fr.cnes.sirius.patrius.math.analysis.function
-
- Gaussian(double, double, double) - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Gaussian
-
Gaussian with given normalization factor, mean and standard deviation.
- Gaussian(double, double) - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Gaussian
-
Normalized gaussian with given mean and standard deviation.
- Gaussian() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Gaussian
-
Normalized gaussian with zero mean and unit standard deviation.
- Gaussian.Parametric - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Parametric function where the input array contains the parameters of
the Gaussian, ordered as follows:
Norm
Mean
Standard deviation
- GAUSSIAN_MODE - Static variable in class fr.cnes.sirius.patrius.math.random.ValueServer
-
Gaussian random deviates with mean = μ, std dev = σ.
- GaussianFitter - Class in fr.cnes.sirius.patrius.math.fitting
-
- GaussianFitter(MultivariateVectorOptimizer) - Constructor for class fr.cnes.sirius.patrius.math.fitting.GaussianFitter
-
Constructs an instance using the specified optimizer.
- GaussianFitter.ParameterGuesser - Class in fr.cnes.sirius.patrius.math.fitting
-
Guesses the parameters
norm,
mean, and
sigma of a
Gaussian.Parametric based on the specified observed points.
- GaussianRandomGenerator - Class in fr.cnes.sirius.patrius.math.random
-
This class is a gaussian normalized random generator for scalars.
- GaussianRandomGenerator(RandomGenerator) - Constructor for class fr.cnes.sirius.patrius.math.random.GaussianRandomGenerator
-
Create a new generator.
- GaussIntegrator - Class in fr.cnes.sirius.patrius.math.analysis.integration.gauss
-
Class that implements the Gaussian rule for
integrating a weighted
function.
- GaussIntegrator(double[], double[]) - Constructor for class fr.cnes.sirius.patrius.math.analysis.integration.gauss.GaussIntegrator
-
Creates an integrator from the given points and weights.
- GaussIntegrator(Pair<double[], double[]>) - Constructor for class fr.cnes.sirius.patrius.math.analysis.integration.gauss.GaussIntegrator
-
Creates an integrator from the given pair of points (first element of
the pair) and weights (second element of the pair.
- GaussIntegratorFactory - Class in fr.cnes.sirius.patrius.math.analysis.integration.gauss
-
- GaussIntegratorFactory() - Constructor for class fr.cnes.sirius.patrius.math.analysis.integration.gauss.GaussIntegratorFactory
-
- GaussNewtonOptimizer - Class in fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian
-
Gauss-Newton least-squares solver.
- GaussNewtonOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.GaussNewtonOptimizer
-
Simple constructor with default settings.
- GaussNewtonOptimizer(boolean, ConvergenceChecker<PointVectorValuePair>) - Constructor for class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.GaussNewtonOptimizer
-
- gcd(int, int) - Static method in class fr.cnes.sirius.patrius.math.util.ArithmeticUtils
-
Computes the greatest common divisor of the absolute value of two
numbers, using a modified version of the "binary gcd" method.
- gcd(long, long) - Static method in class fr.cnes.sirius.patrius.math.util.ArithmeticUtils
-
Gets the greatest common divisor of the absolute value of two numbers, using the "binary gcd" method which avoids
division and modulo operations.
- GCRFProvider - Class in fr.cnes.sirius.patrius.frames.transformations
-
Geocentric Celestial Reference Frame.
- GCRFProvider() - Constructor for class fr.cnes.sirius.patrius.frames.transformations.GCRFProvider
-
- gDataSetsComparison(long[], long[]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.GTest
-
Computes a G (Log-Likelihood Ratio) two sample test statistic for independence comparing frequency counts in
observed1 and observed2.
- gDataSetsComparison(long[], long[]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- GeneralizedFlamsteedSamson - Class in fr.cnes.sirius.patrius.projections
-
Despite the common name, the "Sanson-Flamsteed" projection was not first studied by either Nicholas Sanson (ca. 1650)
or John Flamsteed (1729, published posthumously), but possibly by Mercator — at least it was included for maps of
South America in later editions (1606) of Mercator's atlas, and has been referred to as the Mercator equal-area
projection, or Mercator-Sanson.
- GeneralizedFlamsteedSamson(EllipsoidPoint, double) - Constructor for class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
-
Constructor : Mercator constructor is used with :
a pivot point including reference ellipsoid
a cap
parameter centered set to true
parameter series set to false indicating that inverse transformation is done with iterations : slower but
more accurate
- generate(CIPCoordinates, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinatesGenerator
-
Generate a chronologically sorted list of entries to be cached.
- generate(TidalCorrection, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrectionGenerator
-
Generate a chronologically sorted list of entries to be cached.
- generate(T, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.time.TimeStampedGenerator
-
Generate a chronologically sorted list of entries to be cached.
- generateEphemeris(Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeEphemerisGenerator
-
Computes attitude ephemeris using a fixed or variable time step.
- generateEphemeris(AbsoluteDateInterval, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeEphemerisGenerator
-
Computes attitude ephemeris using a fixed or variable time step and choosing the interval of validity.
- GenericCodingEventDetector - Class in fr.cnes.sirius.patrius.events.postprocessing
-
- GenericCodingEventDetector(EventDetector, String, String, boolean, String) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
- GenericCodingEventDetector(EventDetector, String, String, boolean, String, double, int) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
- GenericCodingEventDetector(EventDetector, String, String) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
- GenericCodingEventDetector(EventDetector, String, String, double, int) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
- GenericInterval<T> - Class in fr.cnes.sirius.patrius.math.interval
-
- Generic class to describe an interval.
- GenericInterval(IntervalEndpointType, T, T, IntervalEndpointType) - Constructor for class fr.cnes.sirius.patrius.math.interval.GenericInterval
-
Constructor.
- GenericTargetDirection - Class in fr.cnes.sirius.patrius.attitudes.directions
-
Direction described by a target PVCoordinatesProvider.
- GenericTargetDirection(PVCoordinatesProvider) - Constructor for class fr.cnes.sirius.patrius.attitudes.directions.GenericTargetDirection
-
Build a direction from a target described by its
PVCoordinatesProvider
- GenericWrenchModel - Class in fr.cnes.sirius.patrius.wrenches
-
This class represents a generic wrench model.
- GenericWrenchModel(ForceModel, Vector3D) - Constructor for class fr.cnes.sirius.patrius.wrenches.GenericWrenchModel
-
Create a generic wrench model.
- GeneticAlgorithm - Class in fr.cnes.sirius.patrius.math.genetics
-
Implementation of a genetic algorithm.
- GeneticAlgorithm(CrossoverPolicy, double, MutationPolicy, double, SelectionPolicy) - Constructor for class fr.cnes.sirius.patrius.math.genetics.GeneticAlgorithm
-
Create a new genetic algorithm.
- genName(String) - Static method in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
-
Generate a name in the form "MASS_
" for this equation.
- GeodPosition - Class in fr.cnes.sirius.patrius.stela.bodies
-
Class representing the Geodetic representation of a position.
- GeodPosition(double, double) - Constructor for class fr.cnes.sirius.patrius.stela.bodies.GeodPosition
-
Constructor
- GeoMagneticDataProvider - Interface in fr.cnes.sirius.patrius.models.earth
-
Interface for geomagnetic data provider.
- GeoMagneticElements - Class in fr.cnes.sirius.patrius.models.earth
-
Contains the elements to represent a magnetic field at a single point.
- GeoMagneticElements(Vector3D) - Constructor for class fr.cnes.sirius.patrius.models.earth.GeoMagneticElements
-
Construct a new element with the given field vector.
- GeoMagneticField - Class in fr.cnes.sirius.patrius.models.earth
-
Used to calculate the geomagnetic field at a given ellipsoid point on earth.
- GeoMagneticField(String, double, int, int, double, double) - Constructor for class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Create a new geomagnetic field model with the given parameters.
- GeoMagneticFieldFactory - Class in fr.cnes.sirius.patrius.models.earth
-
- GeoMagneticFieldFactory.FieldModel - Enum in fr.cnes.sirius.patrius.models.earth
-
The currently supported geomagnetic field models.
- GeoMagneticModelReader - Class in fr.cnes.sirius.patrius.models.earth
-
Loads geomagnetic field models from a given input stream.
- GeoMagneticModelReader(String) - Constructor for class fr.cnes.sirius.patrius.models.earth.GeoMagneticModelReader
-
Simple constructor.
- GeometricMean - Class in fr.cnes.sirius.patrius.math.stat.descriptive.moment
-
- GeometricMean() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Create a GeometricMean instance
- GeometricMean(GeometricMean) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Copy constructor, creates a new GeometricMean identical
to the original
- GeometricMean(SumOfLogs) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Create a GeometricMean instance using the given SumOfLogs instance
- geometricMean(double[]) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the geometric mean of the entries in the input array, or Double.NaN if the array is empty.
- geometricMean(double[], int, int) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the geometric mean of the entries in the specified portion of
the input array, or Double.NaN if the designated subarray
is empty.
- GeometricProperty - Class in fr.cnes.sirius.patrius.assembly.properties
-
This class defines the Geometric Property to be used with
assemblies.
- GeometricProperty(SolidShape) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.GeometricProperty
-
Constructor
- GeometricStationAntenna - Class in fr.cnes.sirius.patrius.groundstation
-
Class representing an a geometric model for a ground station antenna.
- GeometricStationAntenna(TopocentricFrame, IFieldOfView) - Constructor for class fr.cnes.sirius.patrius.groundstation.GeometricStationAntenna
-
Constructor of the ground station antenna (for reverse visibility detection)
- GeometricStationAntenna(TopocentricFrame, double[][]) - Constructor for class fr.cnes.sirius.patrius.groundstation.GeometricStationAntenna
-
Constructor of the ground station antenna (for reverse visibility detection)
- GEOMETRY_EPSILON - Static variable in class fr.cnes.sirius.patrius.utils.UtilsPatrius
-
Epsilon for the geometry aspects.
- get(int) - Method in class fr.cnes.sirius.patrius.math.util.OpenIntToDoubleHashMap
-
Get the stored value associated with the given key
- get(int) - Method in class fr.cnes.sirius.patrius.math.util.OpenIntToFieldHashMap
-
Get the stored value associated with the given key
- get(String) - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Returns the
TimeScale corresponding to the string representation of time scale.
- get24HoursKp(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.DTMInputParameters
-
Get the last 24H mean geomagnetic index.
- get24HoursKp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.DTMSolarData
-
Get the last 24H mean geomagnetic index.
- get24HoursKp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
The Kp index is derived from the Ap index.
- getA() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialFunction
-
Get array of cosine coefficients
- getA() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the equalities constraints matrix
- getA() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the equalities constraints matrix
- getA(int, double) - Method in class fr.cnes.sirius.patrius.math.util.ContinuedFraction
-
Access the n-th a coefficient of the continued fraction.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the semi-major axis.
- getA() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the semi-major axis.
- getA0() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialFunction
-
Get value of order zero coefficient
- getA1() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RotationOrder
-
Get the axis of the first rotation.
- getA2() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RotationOrder
-
Get the axis of the second rotation.
- getA3() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RotationOrder
-
Get the axis of the second rotation.
- getAberrationAngle() - Method in class fr.cnes.sirius.patrius.attitudes.directions.LightAberrationTransformation
-
Getter for the aberration angle [rad].
- getAbs() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns the corresponding absolute values matrix.
- getAbs() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the corresponding absolute values matrix.
- getAbs() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns the corresponding absolute values matrix.
- getAbscissa(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Get the abscissa of a point with respect to the line.
- getAbscissaGrid() - Method in class fr.cnes.sirius.patrius.models.earth.InterpolationTableLoader
-
Returns a copy of the abscissa grid for the interpolation function.
- getAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the actual absolute accuracy.
- getAbsoluteAccuracy() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.UnivariateIntegrator
-
Get the actual absolute accuracy.
- getAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Get the absolute accuracy of the solver.
- getAbsoluteAccuracy() - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BaseUnivariateSolver
-
Get the absolute accuracy of the solver.
- getAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.dfp.BracketingNthOrderBrentSolverDFP
-
Get the absolute accuracy.
- getAbsoluteThreshold() - Method in class fr.cnes.sirius.patrius.math.optim.AbstractConvergenceChecker
-
- getAbsorptionCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
-
Get the parameter representing the absorption coefficient of the part.
- getAbsorptionRatio() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
-
Get the parameter representing the ratio of light absorbed: Ka = α.
- getAbsTol() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquationsAndTolerances
-
Returns absolute tolerance vector.
- getAcceleration() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionDataPoint
-
Returns the XYZ acceleration.
- getAcceleration() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the second time derivative of the translation.
- getAcceleration() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.PVCoordinates
-
Gets the acceleration.
- getAccuracy() - Method in class fr.cnes.sirius.patrius.files.general.SatelliteInformation
-
Returns the estimated accuracy of the orbit entries for this
satellite (in m).
- getAccXArray() - Method in interface fr.cnes.sirius.patrius.forces.gravity.grid.GridSystem
-
Returns X acceleration data array (values along ordinates).
- getAccYArray() - Method in interface fr.cnes.sirius.patrius.forces.gravity.grid.GridSystem
-
Returns Y acceleration data array (values along ordinates).
- getAccZArray() - Method in interface fr.cnes.sirius.patrius.forces.gravity.grid.GridSystem
-
Returns Z acceleration data array (values along ordinates).
- getAction() - Method in class fr.cnes.sirius.patrius.events.detectors.AnomalyDetector
-
Return the action at detection.
- getAction() - Method in class fr.cnes.sirius.patrius.events.detectors.AOLDetector
-
Return the action at detection.
- getAction() - Method in class fr.cnes.sirius.patrius.events.detectors.DateDetector
-
Return the action at detection.
- getAction() - Method in class fr.cnes.sirius.patrius.events.detectors.LocalTimeAngleDetector
-
Return the action at detection.
- getActionAtEntry() - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
- getActionAtExit() - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
- getActionAtOccurrence() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get the action at occurrence.
- getAddEquations() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Get the additional equations.
- getAdditionalEquation(String) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
-
Get the mass equation related to the part.
- getAdditionalEquation(String) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
-
Get the mass equation related to the part.
- getAdditionalEquation(String) - Method in class fr.cnes.sirius.patrius.assembly.models.MassModel
-
Get the mass equation related to the part.
- getAdditionalEquation(String) - Method in interface fr.cnes.sirius.patrius.propagation.MassProvider
-
Get the mass equation related to the part.
- getAdditionalEquation(String) - Method in class fr.cnes.sirius.patrius.propagation.SimpleMassModel
-
Get the mass equation related to the part.
- getAdditionalState(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.AdditionalStateProvider
-
Get the additional state.
- getAdditionalState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.SimpleAdditionalStateProvider
-
Get the additional state.
- getAdditionalState(String) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get one additional state.
- getAdditionalStateDimension() - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Compute the length of the one-dimensional additional state array needed.
- getAdditionalStates() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get additional states.
- getAdditionalStatesInfos() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the additional states informations map.
- getAdditionalStatesMass() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get additional states with the prefix "MASS_".
- getAddStatesInfos(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
-
Get the additional states informations associated with the given spacecraft ID.
- getAdjustedRSquared() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
Returns the adjusted R-squared statistic, defined by the formula
R2adj = 1 - [SSR (n - 1)] / [SSTO (n - p)]
where SSR is the sum of squared residuals}, SSTO is the total sum of squares}, n is the number of observations
and p is the number of parameters estimated (including the intercept).
- getAe() - Method in class fr.cnes.sirius.patrius.forces.gravity.BalminoGravityModel
-
Get the equatorial radius.
- getAe() - Method in class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
Get the equatorial radius.
- getAe() - Method in class fr.cnes.sirius.patrius.forces.gravity.DrozinerGravityModel
-
Get the equatorial radius.
- getAe() - Method in interface fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsProvider
-
Get the value of the central body reference radius.
- getAe() - Method in class fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsReader
-
Get the value of the central body reference radius.
- getAe() - Method in interface fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
-
Get the value of the central body reference radius.
- getAe() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
Get the value of the central body reference radius.
- getAe() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.VariablePotentialGravityModel
-
Get the equatorial radius.
- getAe() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Getter for equatorial radius.
- getAe() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Getter for the equatorial radius.
- getAerodynamicCoefficient() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffConstant
-
Getter for the aerodynamic coefficient.
- getAerodynamicCoefficientsArray() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAoAAndMach
-
Getter for the aerodynamic coefficients array.
- getAerodynamicProperties() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Get main shape aerodynamic properties.
- getAerodynamicsPropertiesFunction() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Returns the aero properties : drag and lift coefficients.
- getAf0() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getAf1() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getAf2() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getAffineLocalExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Express a Vector3D in ellipsoid local basis.
- getAffineLocalExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
Express a Vector3D in spheroid local frame.
- getAffineLocalExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
Express a Vector3D in spheroid local frame.
- getAffineStandardExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Express a Vector3D in standard basis.
- getAffineStandardExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
Express a Vector3D in standard basis.
- getAffineStandardExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
Express a Vector3D in standard basis.
- getAgency() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the agency that prepared this SP3 file.
- getAgents() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.Watcher
-
Getter for the list of agents to be notified if the variable change.
- getAlbedoPressure() - Method in class fr.cnes.sirius.patrius.forces.radiation.ElementaryFlux
-
get the albedo pressure (N/M²)
- getAlignAngle() - Method in class fr.cnes.sirius.patrius.events.detectors.AlignmentDetector
-
Get the alignment angle (rad).
- getAlignmentAngle() - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
Get the alignment angle.
- getAllDerivatives() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Get all partial derivatives.
- getAllowedExtensionBeforeEphemerisReset() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Getter for the maximum allowed reference extensions before reinitialization.
- getAllPartsNames() - Method in class fr.cnes.sirius.patrius.assembly.Assembly
-
Gets the list of the name of the parts in the assembly (the main part is excluded).
- getAllPartsNames() - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
-
Get the list of the name of the parts.
- getAllPartsNames() - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
-
Get the list of the name of the parts.
- getAllPartsNames() - Method in class fr.cnes.sirius.patrius.assembly.models.MassModel
-
Get the list of the name of the parts.
- getAllPartsNames() - Method in interface fr.cnes.sirius.patrius.propagation.MassProvider
-
Get the list of the name of the parts.
- getAllPartsNames() - Method in class fr.cnes.sirius.patrius.propagation.SimpleMassModel
-
Get the list of the name of the parts.
- getAlpha(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.models.cook.AlphaConstant
-
Return alpha (energy accomodation coefficient) value.
- getAlpha(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.models.cook.AlphaCookModel
-
Return alpha (energy accomodation coefficient) value.
- getAlpha(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.assembly.models.cook.AlphaProvider
-
Return alpha (energy accomodation coefficient) value.
- getAlpha() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroProperty
-
Getter for the alpha.
- getAlpha() - Method in class fr.cnes.sirius.patrius.math.distribution.BetaDistribution
-
Access the first shape parameter, alpha.
- getAlpha() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Get the azimuth of the vector.
- getAlpha() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCoordinates
-
Get the azimuth α.
- getAlpha() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
For a given vector, get the angle between projection on XY-plane and X-axis counted in counter-clockwise
direction: 0 corresponds to Vector3D(1, 0, ...), and increasing values are counter-clockwise.
- getAlpha() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
For a given vector, get the angle between vector and X-axis counted in counter-clockwise direction: 0
corresponds to Vector2D(1, 0), and increasing values are counter-clockwise.
- getAlpha() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the calibration parameter for line search
- getAlpha() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the calibration parameter for line search
- getAlpha(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the latitude argument.
- getAlpha(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Get the latitude argument.
- getAlpha0Coeffs() - Method in class fr.cnes.sirius.patrius.bodies.IAUPoleCoefficients
-
Returns the coefficients for α0 component.
- getAlphaE() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the eccentric latitude argument.
- getAlphaE() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Get the eccentric latitude argument.
- getAlphaM() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the mean latitude argument.
- getAlphaM() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Get the mean latitude argument.
- getAlphaV() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the true latitude argument.
- getAlphaV() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Get the true latitude argument.
- getAlt() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for alt.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Getter for underlying equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAlternateEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into alternate equinoctial parameters.
- getAltitude() - Method in class fr.cnes.sirius.patrius.events.detectors.AltitudeDetector
-
Getter for the threshold altitude value.
- getAltitude() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Getter for the altitude.
- getAltitude() - Method in class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
-
Get the threshold altitude value.
- getAncestor(int) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the nth ancestor of the frame.
- getAnelasticityCorrectionLoveNumber2() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.ITerrestrialTidesDataProvider
-
Get second degree Love number for the third body perturbation.
- getAnelasticityCorrectionLoveNumber2() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.TerrestrialTidesDataProvider
-
Get second degree Love number for the third body perturbation.
- getAnelasticityCorrectionLoveNumber3() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.ITerrestrialTidesDataProvider
-
Get third degree Love number for the third body perturbation.
- getAnelasticityCorrectionLoveNumber3() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.TerrestrialTidesDataProvider
-
Get third degree Love number for the third body perturbation.
- getAngle() - Method in class fr.cnes.sirius.patrius.events.detectors.BetaAngleDetector
-
Returns beta angle triggering the event.
- getAngle() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldRotation
-
Get the angle of the rotation.
- getAngle() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCone
-
- getAngle() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCone
-
- getAngle() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Rotation
-
Get the angle of the rotation. inverse trigo function are protected because for a normalize
quaternion it is not possible to have asin(x > 1) when q0 is different from 0 else acos is
called with a value between -0.1 and 0.1.
- getAngle() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Get the angle of the line.
- getAngleBewteen2Vector3D(Vector3D, Vector3D) - Static method in class fr.cnes.sirius.patrius.math.interval.AngleTools
-
Computes the angle between 2 vectors 3D.
- getAngleFromCosineAndSine(double, double) - Static method in class fr.cnes.sirius.patrius.math.interval.AngleTools
-
Computes an angle from the sine and the cosine
- getAngleOfAttack(SpacecraftState) - Method in class fr.cnes.sirius.patrius.attitudes.AeroAttitudeLaw
-
Getter for the angle of attack.
- getAngles(RotationOrder) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EulerRotation
-
Get the Cardan or Euler angles corresponding to the instance.
- getAngles() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EulerRotation
-
Get the Cardan or Euler angles corresponding to the instance in the initial rotation order.
- getAngles(RotationOrder) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldRotation
-
Get the Cardan or Euler angles corresponding to the instance.
- getAngles(RotationOrder) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Rotation
-
Get the Cardan or Euler angles corresponding to the instance.
- getAngleType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Getter for the position angle type.
- getAngleU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCone
-
- getAngleU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCone
-
- getAngleV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCone
-
- getAngleV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCone
-
- getAngleX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This method returns the angle of the cone along X axis
- getAngleY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This method returns the angle of the cone along Y axis
- getAngular() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the orientation and rotation rate of the "destination" frame in the "origin" one.
- getAngularCoordinates(AbsoluteDate, IAUPoleModelType) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyIAUOrientation
-
Getter for the orientation from the ICRF frame to the rotating frame.
- getAngularCoordinates(AbsoluteDate, CelestialBodyOrientation.OrientationType, IAUPoleModelType) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyIAUOrientation
-
Getter for the orientation.
- getAngularCoordinates(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyOrientation
-
Getter for the orientation from the ICRF frame to the rotating frame.
- getAngularCoordinates(AbsoluteDate, CelestialBodyOrientation.OrientationType) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyOrientation
-
Getter for the orientation.
- getAngularCoordinates(AbsoluteDate, CelestialBodyOrientation.OrientationType) - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Getter for the orientation.
- getAngularCoordinates(AbsoluteDate, CelestialBodyOrientation.OrientationType) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the orientation.
- getAngularCoordinates(AbsoluteDate, CelestialBodyOrientation.OrientationType, IAUPoleModelType) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the orientation.
- getAngularDerivativeFilter() - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Getter for the angular derivative filter.
- getAngularDistance(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.AzimuthElevationField
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.BooleanField
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D, AngularDistanceType) - Method in class fr.cnes.sirius.patrius.fieldsofview.CircularField
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D, AngularDistanceType) - Method in class fr.cnes.sirius.patrius.fieldsofview.EllipticField
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D) - Method in interface fr.cnes.sirius.patrius.fieldsofview.IFieldOfView
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D, AngularDistanceType) - Method in interface fr.cnes.sirius.patrius.fieldsofview.IGeometricFieldOfView
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D) - Method in interface fr.cnes.sirius.patrius.fieldsofview.IGeometricFieldOfView
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.InvertField
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.OmnidirectionalField
-
this method has no sense in the case of an omnidirectional field.
- getAngularDistance(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.PyramidalField
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D, AngularDistanceType) - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
-
Computes the angular distance between a vector and the border of the field.
- getAngularDistance(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.SectorField
-
Computes the angular distance between a vector and the border of the field.
- getAngularFrequencies() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesHarmonicProfile
-
Gets the angular frequencies of the three Fourier series representing x, y and z.
- getAngularFrequencies() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
- getAngularFrequency() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
- getAngularOpening(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.CircularField
-
Get the angular opening of the Field Of View (FOV) over a given direction.
- getAngularOpening(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.EllipticField
-
Get the angular opening of the Field Of View (FOV) over a given direction.
- getAngularOpening(Vector3D) - Method in interface fr.cnes.sirius.patrius.fieldsofview.IGeometricFieldOfView
-
Get the angular opening of the Field Of View (FOV) over a given direction.
- getAngularOpening(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
-
Get the angular opening of the Field Of View (FOV) over a given direction.
- getAngularVelocity() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.PVCoordinates
-
Get the angular velocity (spin) of this point as seen from the origin.
- getAnomaly() - Method in class fr.cnes.sirius.patrius.events.detectors.AnomalyDetector
-
Get the anomaly to detect.
- getAnomaly(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the anomaly.
- getAnomaly(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the anomaly.
- getAnomaly(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the anomaly.
- getAnomaly(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Get the anomaly.
- getAnomaly(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Get the anomaly.
- getAnomaly(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Get the anomaly.
- getAnomaly(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Get the anomaly.
- getAnomalyType() - Method in class fr.cnes.sirius.patrius.events.detectors.AnomalyDetector
-
Get the type of anomaly to detect.
- getAoAArray() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAoAAndMach
-
Getter for the Angles of Attack array.
- getAOL() - Method in class fr.cnes.sirius.patrius.events.detectors.AOLDetector
-
Get the AOL to detect.
- getAOLFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.AOLDetector
-
Get the reference frame.
- getAolModel() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Get the argument of latitude parameter model.
- getAOLType() - Method in class fr.cnes.sirius.patrius.events.detectors.AOLDetector
-
Get the type of AOL to detect.
- getAp(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
Get the Geomagnetic planetary 3-hour index Ap.
- getAp() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.ApCoef
-
Getter for AP.
- getAp() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for ap.
- getAp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get Geomagnetic activity Ap value at given user date
- getAp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get Geomagnetic activity Ap value at given user date
- getAp(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get Geomagnetic activity Ap value at given user date
- getAp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get Geomagnetic activity Ap value at given user date
- getAp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaLOSConstantSolarActivity
-
Get Geomagnetic activity at a specified date.
- getAp(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.stela.forces.solaractivity.IStelaSolarActivity
-
Get Geomagnetic activity at a specified date.
- getAp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableDispersedSolarActivity
-
Get Geomagnetic activity at a specified date.
- getAp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Get Geomagnetic activity at a specified date.
- getApA() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for apA.
- getApCoef() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.Stela3StepsSolarActivity
-
Getter for the Ap dispersion coefficient.
- getApCoef() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableDispersedSolarActivity
-
Get the AP coefficient of the variable solar activity.
- getApertureX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This method returns the aperture of the cone along X axis
- getApertureY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This method returns the aperture of the cone along Y axis
- getApKpMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get maximum date of ap / kp values
- getApKpMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get maximum date of ap / kp values
- getApKpMaxDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get maximum date of ap / kp values
- getApKpMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get maximum date of ap / kp values
- getApKpMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get minimum date of ap / kp values
- getApKpMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get minimum date of ap / kp values
- getApKpMinDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get minimum date of ap / kp values
- getApKpMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get minimum date of ap / kp values
- getApKpValues(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get ap / kp values between the given dates
- getApKpValues(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get ap / kp values between the given dates
- getApKpValues(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get ap / kp values between the given dates
- getApKpValues(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get ap / kp values between the given dates
- getApoapsis() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the apoapsis.
- getApoapsis() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Get the apoapsis.
- getApoapsisAltitude() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Get the apoapsis altitude.
- getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, AbstractSignalPropagationDetector.PropagationDelayType) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Compute the apparent radius (in meters) of the occulting body from the spacecraft (observer) position.
- getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, AbstractSignalPropagationDetector.PropagationDelayType) - Method in interface fr.cnes.sirius.patrius.bodies.ApparentRadiusProvider
-
Compute the apparent radius (in meters) of the occulting body from the spacecraft (observer) position.
- getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, AbstractSignalPropagationDetector.PropagationDelayType) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Compute the apparent radius (in meters) of the occulting body from the spacecraft (observer) position.
- getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, AbstractSignalPropagationDetector.PropagationDelayType) - Method in class fr.cnes.sirius.patrius.bodies.ConstantRadiusProvider
-
Compute the apparent radius (in meters) of the occulting body from the spacecraft (observer) position.
- getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, AbstractSignalPropagationDetector.PropagationDelayType) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Compute the apparent radius (in meters) of the occulting body from the spacecraft (observer) position.
- getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, AbstractSignalPropagationDetector.PropagationDelayType) - Method in class fr.cnes.sirius.patrius.bodies.VariableRadiusProvider
-
Compute the apparent radius (in meters) of the occulting body from the spacecraft (observer) position.
- getApplicationPoint() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroApplicationPoint
-
Get the application point in the given frame at the given date.
- getApplicationPoint() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeApplicationPoint
-
Get the application point in the part frame
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisAltitudeParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into apsis (using altitude) parameters.
- getApsisParameters() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Getter for underlying apsis parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApsisRadiusParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into apsis (using radius) parameters.
- getApValues(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000InputParameters
-
Get the array containing the 7 ap values
- getApValues(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
-
Get the array containing the 7 ap values
- getApValues(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.ClassicalMSISE2000SolarData
-
Get the array containing the 7 ap values
- getApValues(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.ContinuousMSISE2000SolarData
-
Get the array containing the 7 ap values
- getARadius() - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Getter for the semi axis A.
- getARadius() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Getter for the semi axis A.
- getaRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getArchAndType(File) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceKernelManager
-
Determine the architecture and type of SPICE kernels.
- getArchitectureFromHandle(int) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandleManager
-
Indicate the architecture of the file associated to handle.
- getArea() - Method in class fr.cnes.sirius.patrius.assembly.properties.features.Facet
-
- getArgument() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Compute the argument of this complex number.
- getArgument() - Method in exception fr.cnes.sirius.patrius.math.exception.MathIllegalNumberException
-
- getArity() - Method in class fr.cnes.sirius.patrius.math.genetics.TournamentSelection
-
Gets the arity (number of chromosomes drawn to the tournament).
- getArrayIndex(int[], int) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.util.ArrayUtils
-
Finds the index of the given value in the array.
- getArrayMinIndex(int[]) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.util.ArrayUtils
-
Finds the index of the minimum value in the array.
- getArrayRef() - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Provides direct access to the internal storage array.
- getAssembly() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
-
assembly getter
- getAssembly() - Method in class fr.cnes.sirius.patrius.assembly.models.SecondarySpacecraft
-
- getAssembly() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getAssembly() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractStationToSatDetector
-
Get the assembly.
- getAssembly() - Method in class fr.cnes.sirius.patrius.events.detectors.MaskingDetector
-
Get the assembly.
- getAssembly() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Get the assembly.
- getAssembly() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Getter for the assembly.
- getAssembly() - Method in class fr.cnes.sirius.patrius.events.detectors.TargetInFieldOfViewDetector
-
Get the assembly.
- getAssembly() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Getter for the assembly used at construction.
- getAssembly() - Method in interface fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationSensitive
-
assembly getter
- getAssociatedFieldDescriptors() - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Gets the field descriptors currently associated with this parameter descriptor.
- getAssociatedFields() - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Gets the field descriptors currently associated with this parameter descriptor and the values
mapped to them.
- getAT() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the equalities constraints matrix transposed
- getAtmosphere() - Method in class fr.cnes.sirius.patrius.forces.drag.DragForce
-
Get the atmosphere model.
- getAtmosphericLoss(double) - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
-
Gets the atmospheric loss using a spline interpolation.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointing
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AeroAttitudeLaw
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeLawLeg
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeLegLaw
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.attitudes.AttitudeProvider
-
Compute the attitude corresponding to an orbital state.
- getAttitude(Orbit) - Method in interface fr.cnes.sirius.patrius.attitudes.AttitudeProvider
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudesSequence
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.BodyCenterPointing
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.CelestialBodyPointed
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.ComposedAttitudeLaw
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.ConstantAttitudeLaw
-
Compute the attitude corresponding to an orbital state.
- getAttitude(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Compute the attitude.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.FixedRate
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.IsisSunAndPseudoSpinPointing
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.IsisSunPointing
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.LofOffset
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.LofOffsetPointing
-
Compute the attitude corresponding to an orbital state.
- getAttitude(Map<String, PVCoordinatesProvider>, AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.attitudes.multi.MultiAttitudeProvider
-
Computes the attitude corresponding to several orbital states.
- getAttitude(Map<String, Orbit>) - Method in interface fr.cnes.sirius.patrius.attitudes.multi.MultiAttitudeProvider
-
Computes the attitude corresponding to several orbital states.
- getAttitude(Map<String, PVCoordinatesProvider>, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.multi.MultiAttitudeProviderWrapper
-
Computes the attitude corresponding to several orbital states.
- getAttitude(Map<String, Orbit>) - Method in class fr.cnes.sirius.patrius.attitudes.multi.MultiAttitudeProviderWrapper
-
Computes the attitude corresponding to several orbital states.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAngularVelocitiesAttitudeProfile
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Compute the attitude corresponding to an orbital state.
- getAttitude(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialSlew
-
Compute the attitude.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfilesSequence
-
Gets the attitude from the sequence.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialProfile
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialProfile
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.RelativeTabulatedAttitudeLaw
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.RelativeTabulatedAttitudeLeg
-
Compute the attitude corresponding to an orbital state.
- getAttitude(AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.attitudes.Slew
-
Compute the attitude.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.SpinStabilized
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.StrictAttitudeLegsSequence
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Compute the attitude corresponding to an orbital state.
- getAttitude(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Compute the attitude on the specified date in the reference frame.
- getAttitude(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Compute the attitude on the specified date.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedSlew
-
Compute the attitude corresponding to an orbital state.
- getAttitude(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedSlew
-
Compute the attitude on the specified date.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.TargetPointing
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.TwoDirectionAttitudeLaw
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.YawCompensation
-
Compute the attitude corresponding to an orbital state.
- getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.YawSteering
-
Compute the attitude corresponding to an orbital state.
- getAttitude() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the default attitude : the attitude for forces computation.
- getAttitude(Frame) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the default attitude : the attitude for forces computation in given output frame.
- getAttitude(LOFType) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the default attitude : the attitude for forces computation in given local
orbital frame.
- getAttitudeEvents() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the attitude for events computation.
- getAttitudeEvents(Frame) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the attitude for events computation in given output frame.
- getAttitudeEvents(LOFType) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the attitude for events computation in given local orbital frame.
- getAttitudeForces() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the attitude for forces computation.
- getAttitudeForces(Frame) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the attitude for forces computation in given output frame.
- getAttitudeForces(LOFType) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the attitude for forces computation in given local orbital frame.
- getAttitudeLaw() - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeLawLeg
-
Gets the attitude law provider associated to the current attitude leg.
- getAttitudeProvider() - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeFrame
-
Gets the attitude provider defining the orientation of the frame.
- getAttitudeProvider() - Method in class fr.cnes.sirius.patrius.attitudes.multi.MultiAttitudeProviderWrapper
-
Returns the AttitudeProvider.
- getAttitudeProvider() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Get attitude provider.
- getAttitudeProvider(String) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get the default attitude provider.
- getAttitudeProvider(String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Get the default attitude provider.
- getAttitudeProvider(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the default attitude provider.
- getAttitudeProvider() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get attitude provider.
- getAttitudeProvider() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Get attitude provider.
- getAttitudeProvider() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get attitude provider.
- getAttitudeProviderEvents() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Get attitude provider for events computation.
- getAttitudeProviderEvents(String) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get the attitude provider for events computation.
- getAttitudeProviderEvents(String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Get the attitude provider for events computation.
- getAttitudeProviderEvents(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the attitude provider for events computation.
- getAttitudeProviderEvents() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get attitude provider for events computation.
- getAttitudeProviderEvents() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Get attitude provider for events computation.
- getAttitudeProviderEvents() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get attitude provider for events computation.
- getAttitudeProviderForces() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Get attitude provider for forces computation.
- getAttitudeProviderForces(String) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get the attitude provider for forces computation.
- getAttitudeProviderForces(String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Get the attitude provider for forces computation.
- getAttitudeProviderForces(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the attitude provider for forces computation.
- getAttitudeProviderForces() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get attitude provider for forces computation.
- getAttitudeProviderForces() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Get attitude provider for forces computation.
- getAttitudeProviderForces() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get attitude provider for forces computation.
- getAttitudes() - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Getter for the non-interpolated and rightly ordered attitudes.
- getAttitudeType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AttitudeEquation
-
Get the attitude type.
- getAttitudeType() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAttitudeAdditionalEquations
-
Get the attitude type.
- getAttribute() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BSPTree
-
Get the attribute associated with the instance.
- getAvailableForceModels() - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
-
Returns available force models.
- getAvailableForceModelsSTM() - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
-
Returns available force models for state transition matrix.
- getAvailableGrids() - Static method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGridUtils
-
Get all the available grids.
- getAvailableLocales() - Static method in class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Get the set of locales for which complex formats are available.
- getAvailableLocales() - Static method in class fr.cnes.sirius.patrius.math.fraction.BigFractionFormat
-
Get the set of locales for which complex formats are available.
- getAvailableLocales() - Static method in class fr.cnes.sirius.patrius.math.fraction.FractionFormat
-
Get the set of locales for which complex formats are available.
- getAvailableLocales() - Static method in class fr.cnes.sirius.patrius.math.geometry.VectorFormat
-
Get the set of locales for which point/vector formats are available.
- getAvailableLocales() - Static method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Get the set of locales for which real vectors formats are available.
- getAvailableLocales() - Static method in class fr.cnes.sirius.patrius.math.linear.RealVectorFormat
-
Get the set of locales for which real vectors formats are available.
- getAvailableParameters() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Get the names of the available parameters in the propagator.
- getAvailableSatelliteNumbers() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLESeries
-
Get the available satellite numbers.
- getAverageFlux(AbsoluteDate, AbsoluteDate, SolarActivityDataProvider) - Static method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityToolbox
-
Compute mean flux between given dates.
- getAx() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the parametereziable function for the Ax coefficient.
- getAxis() - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleTransform
-
Returns the axis of the transform in the frame defined by the reference transform.
- getAxis() - Method in class fr.cnes.sirius.patrius.attitudes.SpinStabilized
-
Getter for the rotation axis in satellite frame.
- getAxis() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldRotation
-
Get the normalized axis of the rotation.
- getAxis() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCone
-
- getAxis() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCone
-
- getAxis() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Rotation
-
Get the normalized axis of the rotation.
- getAxis1() - Method in class fr.cnes.sirius.patrius.events.detectors.DihedralFieldOfViewDetector
-
Get the direction of fov 1st dihedral axis.
- getAxis2() - Method in class fr.cnes.sirius.patrius.events.detectors.DihedralFieldOfViewDetector
-
Get the direction of fov 2nd dihedral axis.
- getAxisOne() - Method in class fr.cnes.sirius.patrius.frames.TwoDirectionFrame
-
- getAxisTwo() - Method in class fr.cnes.sirius.patrius.frames.TwoDirectionFrame
-
- getAy() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the parametereziable function for the Ay coefficient.
- getAz() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the parametereziable function for the Az coefficient.
- getAzimuth(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the azimuth of a point with regards to the topocentric frame center point.
- getAzimuth(Vector3D, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AzimuthElevationCalculator
-
Compute the Azimuth of a point defined by its Cartesian coordinates in a
Frame whose x, y and "Reference Azimuth" axis are in the same Plane
- getAzimuth() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Getter for the azimuth of velocity.
- getAzimuth() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPosition
-
Get the azimuth angle.
- getAzimuth() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPV
-
Get the azimuth angle.
- getAzimuth() - Method in class fr.cnes.sirius.patrius.projections.Mercator
-
Get the azimuth of the projection (CLOCKWISE).
- getAzimuthRate(PVCoordinates, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the azimuth rate of a point.
- getAzimuthRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPV
-
Get the azimuth rate.
- getB() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialFunction
-
Get array of sine coefficients
- getB() - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the matrix B of the decomposition A = B×BT of this matrix.
- getB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the equalities constraints vector
- getB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the equalities constraints vector
- getB(int, double) - Method in class fr.cnes.sirius.patrius.math.util.ContinuedFraction
-
Access the n-th b coefficient of the continued fraction.
- getBackupModel() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.GridGravityModel
-
Getter for the backup model
- getBackward() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.FileRecordDAF
-
Getter for the last summary record.
- getBalmino(EarthGravitationalModelFactory.GravityFieldNames, String, int, int, boolean) - Static method in class fr.cnes.sirius.patrius.forces.gravity.EarthGravitationalModelFactory
-
Create an instance of a central body attraction with normalized coefficients, Helmholtz Polynomials (Balmino
model) and specific data.
- getBarrierFunction() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.BarrierMethod
-
Get the barrier function
- getBarycenter() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Interval
-
Get the barycenter of the interval.
- getBarycenter() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Get the barycenter of the instance.
- getBarycenter() - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Region
-
Get the barycenter of the instance.
- getBaseState(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointingWrapper
-
Compute the base system state at given date, without compensation.
- getBaseSurface() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
Returns the surface of the cylinder base.
- getBasicDimension() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get state vector dimension without additional parameters.
- getBeta() - Method in class fr.cnes.sirius.patrius.math.distribution.BetaDistribution
-
Access the second shape parameter, beta.
- getBeta() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the calibration parameter for line search
- getBeta() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the calibration parameter for line search
- getBiggerLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
Get the polygon's bigger length, i.e. the largest size among its points.
- getBinaryFileFormatFromHandle(int) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandleManager
-
Indicate the binary file format of the file associated to handle.
- getBinCount() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Returns the number of bins.
- getBinStats() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Returns a List of
SummaryStatistics instances containing
statistics describing the values in each of the bins.
- getBitRate() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
-
- getBodies() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Returns the celestial bodies/points map available in the factory.
- getBody(String) - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get a celestial body.
- getBody() - Method in class fr.cnes.sirius.patrius.events.detectors.DistanceDetector
-
Returns the body whose distance is watched.
- getBody() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaDistanceDetector
-
- getBody() - Method in class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Getter for the body.
- getBodycodenamemapping() - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceBody
-
Gets the BodyCodeNameMapping
- getBodyDistanceType() - Method in class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Getter for the chosen body distance type for the detector.
- getBodyFixedFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Getter for the body fixed frame.
- getBodyFrame() - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointing
-
Getter for the body frame.
- getBodyFrame() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
Getter for the body frame related to body shape.
- getBodyFrame() - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Getter for the body frame related to body shape.
- getBodyFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaLatitudeDetector
-
Returns the body frame.
- getBodyFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaLongitudeDetector
-
Returns the body frame.
- getBodyFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.LongitudeDetector
-
Returns central body frame.
- getBodyFrame() - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractGravityModel
-
Get the central body frame.
- getBodyFrame() - Method in interface fr.cnes.sirius.patrius.forces.gravity.GravityModel
-
Get the central body frame.
- getBodyLink() - Method in class fr.cnes.sirius.patrius.bodies.bsp.BSPEphemerisLoader
-
Returns the BSP body name linked to PATRIUS frame tree.
- getBodyNature() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Getter for the celestial body nature.
- getBodyNature() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialPoint
-
Getter for the celestial point nature.
- getBodyPoint() - Method in class fr.cnes.sirius.patrius.events.detectors.BodyPointLocalTimeAngleDetector
-
Getter for the body point
- getBodyShape() - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointing
-
Getter for the body shape.
- getBodyShape() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Get the
BodyShape associated to this body point.
- getBodyShape() - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Get the
BodyShape associated to this body point.
- getBodyShape() - Method in class fr.cnes.sirius.patrius.bodies.EllipsoidPoint
-
Get the
BodyShape associated to this body point.
- getBodyShape() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetPoint
-
Get the
BodyShape associated to this body point.
- getBodyShape() - Method in class fr.cnes.sirius.patrius.bodies.VariableRadiusProvider
-
Getter for boy shape.
- getBodyShape() - Method in class fr.cnes.sirius.patrius.events.detectors.AltitudeDetector
-
Getter for the body shape.
- getBodyShape() - Method in class fr.cnes.sirius.patrius.events.detectors.NadirSolarIncidenceDetector
-
Getter for the body shape.
- getBodyShape() - Method in class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Getter for the body shape.
- getBodyShape() - Method in class fr.cnes.sirius.patrius.events.detectors.VisibilityFromStationDetector
-
Getter for the body shape.
- getBoldLineSeparator() - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Getter for the String representing the bold line separator.
- getBoundarySize() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Get the size of the boundary.
- getBoundarySize() - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Region
-
Get the size of the boundary.
- getBoundIsAllowed() - Method in exception fr.cnes.sirius.patrius.math.exception.NumberIsTooLargeException
-
- getBoundIsAllowed() - Method in exception fr.cnes.sirius.patrius.math.exception.NumberIsTooSmallException
-
- getBracketingStep() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.BracketingStep
-
Gets the initial step.
- getBRadius() - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Getter for the semi axis B.
- getBRadius() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Getter for the semi axis B.
- getBRep() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.PolyhedronsSet
-
Get the boundary representation of the instance.
- getBStar() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the ballistic coefficient.
- getBT() - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the matrix BT of the decomposition A = B×BT of this matrix.
- getBT(boolean) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the matrix BT of the decomposition A = B×BT of this matrix.
- getBx() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the parametereziable function for the Bx coefficient.
- getBy() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the parametereziable function for the By coefficient.
- getBz() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the parametereziable function for the Bz coefficient.
- getC() - Method in class fr.cnes.sirius.patrius.forces.gravity.BalminoGravityModel
-
- getC() - Method in class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
- getC() - Method in class fr.cnes.sirius.patrius.forces.gravity.DrozinerGravityModel
-
- getC(int, int, boolean) - Method in interface fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsProvider
-
Get the tesseral-sectorial and zonal coefficients.
- getC(int, int, boolean) - Method in class fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsReader
-
Get the tesseral-sectorial and zonal coefficients.
- getC() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the linear objective function
- getC() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Get the linear objective function
- getC1() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getC2() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getC3() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getC4() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getCacheReusabilityRatio() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Provides the ratio of reusability of the internal cache.
- getCacheReusabilityRatio() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Provides the ratio of reusability of the internal cache.
- getCacheSlotsNumber() - Static method in class fr.cnes.sirius.patrius.utils.PatriusConfiguration
-
Get the number of slots to use in caches.
- getCalendarWeek() - Method in class fr.cnes.sirius.patrius.time.DateComponents
-
Get the calendar week number.
- getCalls() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the number of calls to the differential equations computation method.
- getCalls() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get the number of calls to the differential equations computation method.
- getCallThreadName() - Method in class fr.cnes.sirius.patrius.tools.parallel.AbstractSimpleParallelTaskImpl
-
- getCapacity() - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Gets the currently allocated size of the internal data structure used
for storing elements.
- getCapitalizedAbbreviation() - Method in enum fr.cnes.sirius.patrius.time.Month
-
Get the capitalized three letters abbreviation.
- getCapitalizedName() - Method in enum fr.cnes.sirius.patrius.time.Month
-
Get the capitalized full name.
- getCardanMountPosition() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Get the Cardan mount position.
- getCartesian() - Method in class fr.cnes.sirius.patrius.frames.transformations.HelmertTransformation
-
Returns the Cartesian part of the transform.
- getCartesian() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the position and velocity of the "destination" frame in the "origin" one.
- getCartesianCoordinates(double, double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Convert from Ellipsoid to Cartesian coordinates
- getCartesianCoordinates() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCoordinates
-
Returns the cartesian coordinates.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Getter for underlying circular parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into cartesian parameters.
- getCartesianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into cartesian parameters.
- getCcm() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getCcp() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getCdMap() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoef
-
Get the spacecraft drag coefficient map
- getCeilingIndex(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the ceiling index for the given date.
- getCeilingSample(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the ceiling sample for the given date.
- getCelestialPoint() - Method in class fr.cnes.sirius.patrius.frames.CelestialBodyFrame
-
Getter for the celestial point centered on this frame.
- getCelestialPoint() - Method in class fr.cnes.sirius.patrius.frames.PredefinedFrame
-
Returns the celestial point centered on this frame.
- getCelestialPoint() - Method in enum fr.cnes.sirius.patrius.frames.PredefinedFrameType
-
Returns the celestial point associated to Predefined frame key.
- getCell(Vector<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BSPTree
-
Get the cell to which a point belongs.
- getCenter() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Getter for the triangle barycenter.
- getCenter() - Method in class fr.cnes.sirius.patrius.events.detectors.CircularFieldOfViewDetector
-
Get the direction of fov center.
- getCenter() - Method in class fr.cnes.sirius.patrius.events.detectors.DihedralFieldOfViewDetector
-
Get the direction of fov center.
- getCenter() - Method in class fr.cnes.sirius.patrius.frames.LocalOrbitalFrame
-
Returns the center of the LOF.
- getCenter() - Method in class fr.cnes.sirius.patrius.frames.TranslatedFrame
-
Returns the center of this frame.
- getCenter() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractEllipse
-
- getCenter() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Get ellipsoid center
- getCenter() - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.IEllipsoid
-
Get ellipsoids' center
- getCenter() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
- getCenter() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getCenter() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
- getCenter() - Method in class fr.cnes.sirius.patrius.math.stat.clustering.Cluster
-
Get the point chosen to be the center of this cluster.
- getCenteredModel() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DParameterModel
-
Get model for centered part of analytical model.
- getCenteredValue(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DParameterModel
-
Get the centered value of the model.
- getCenterOfMass() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionData
-
Returns the center of mass position of the body.
- getCenters() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of the centers array.
- getCentralBodyShape() - Method in class fr.cnes.sirius.patrius.events.detectors.EarthZoneDetector
-
Getter for the central body shape.
- getCentralEccentricity() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for the central eccentricity ec.
- getChebyshevAbscissas(int) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Compute the N Chebyshev abscissas on the range [start ; end] in a chronological (increasing) order.
- getChebyshevAbscissas(int) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialChebyshevFunction
-
Compute the N Chebyshev abscissas on the range [start ; end] in a chronological (increasing)
order..
- getChebyshevAbscissas(double, double, int) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialsUtils
-
Compute the N Chebyshev abscissas on the range [start ; end] in a chronological (increasing) order.
- getCheck() - Method in class fr.cnes.sirius.patrius.math.linear.ConjugateGradient
-
Returns true if positive-definiteness should be checked for both
matrix and preconditioner.
- getCheck() - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns true if symmetry of the matrix, and symmetry as well as
positive definiteness of the preconditioner should be checked.
- getChiSquare() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
-
Get a Chi-Square-like value assuming the N residuals follow N
distinct normal distributions centered on 0 and whose variances are
the reciprocal of the weights.
- getChromosomeList() - Method in class fr.cnes.sirius.patrius.math.genetics.ListPopulation
-
Access the list of chromosomes.
- getChromosomes() - Method in class fr.cnes.sirius.patrius.math.genetics.ListPopulation
-
Returns an unmodifiable list of the chromosomes in this population.
- getCic() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getCIPCoordinates(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Compute the corrected Celestial Intermediate Pole motion (X, Y, S, Xdot, Ydot, Sdot) in the GCRS.
- getCIPCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Compute the corrected Celestial Intermediate Pole motion (X, Y, S, Xdot, Ydot, Sdot) in the GCRS.
- getCIPCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.IERS20032010PrecessionNutation
-
Getter for the CIP coordinates at the provided date.
- getCIPCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.NoPrecessionNutation
-
Getter for the CIP coordinates at the provided date.
- getCIPCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutation
-
Compute the CIP pole coordinates at given date.
- getCIPCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationCache
-
Deprecated.
Getter for the CIP coordinates at the provided date.
- getCIPCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Getter for the CIP coordinates at the provided date.
- getCIPCoordinates(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationModel
-
Getter for the CIP coordinates at the provided date.
- getCIPCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationPerThread
-
Getter for the CIP coordinates at the provided date.
- getCIPCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.StelaPrecessionNutationModel
-
- getCIPMotion() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Get for the CIP motion.
- getCIPMotion(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationCache
-
Deprecated.
Compute the Celestial Intermediate pole motion in the GCRS.
- getCIPMotionTimeDerivative(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationCache
-
Deprecated.
Compute the Celestial Intermediate pole motion in the GCRS.
- getCIPMotionTimeDerivatives() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Getter for the CIP motion time derivatives.
- getCircuitLoss() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
-
- getCircularEx() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the first component of the circular eccentricity vector.
- getCircularEx() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Get the first component of the circular eccentricity vector.
- getCircularEy() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the second component of the circular eccentricity vector.
- getCircularEy() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Get the second component of the circular eccentricity vector.
- getCircularFOVDetector() - Method in class fr.cnes.sirius.patrius.events.detectors.CentralBodyMaskCircularFOVDetector
-
Get the circular FOV detector.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Getter for underlying circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into circular parameters.
- getCircularParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into circular parameters.
- getCIRF() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the CIRF reference frame.
- getCIRFPrecessionNutationModel() - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Get the CIRF precession nutation model.
- getCIRFPrecessionNutationModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Get the CIRF precession nutation model.
- getCis() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getClassification() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
- getClassification() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the classification.
- getClockCorrection() - Method in class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
Returns the clock correction value.
- getClockCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSPVCoordinates
-
Compute the correction term for the offset of the satellite's transmission time of signal
- getClockRateChange() - Method in class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
Returns the clock rate change value.
- getClosestPoint(Vector2D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Segment
-
Returns closest point of provided point belonging to segment.
- getClosestPointOnShape() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Returns the closest point to this on the shape surface.
- getClosestPointOnShape() - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Returns the closest point to this on the shape surface.
- getClosestPointOnShape() - Method in class fr.cnes.sirius.patrius.bodies.EllipsoidPoint
-
Returns the closest point to this on the shape surface.
- getClosestPointOnShape() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetPoint
-
Returns the closest point to this on the shape surface.
- getClosestTLE(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLESeries
-
Get the closest TLE to the selected date.
- getClosestTriangles() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetPoint
-
Get the list of shape triangles closest to this.
- getCm() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getCode() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEvent
-
- getCode() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Phenomenon
-
- getCodedEvent() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsLogger.LoggedCodedEvent
-
Gets the coded event.
- getCodedEvent() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiCodedEventsLogger.MultiLoggedCodedEvent
-
Gets the coded event in multi propagation context.
- getCodedEvents() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
-
- getCodedEventsList() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsLogger
-
- getCodedEventsList() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiCodedEventsLogger
-
- getCodedEventsList() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
-
- getCoef() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDispersedDragCoef
-
Get the coefficient of the variable drag coef.
- getCoefC() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefC
- getCoefCCos1A() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefCCos1A
- getCoefCCos2A() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefCCos2A
- getCoefCDrift() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefCDrift
- getCoefCSin1A() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefCSin1A
- getCoefCSin2A() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefCSin2A
- getCoefficient(int, int) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.ZernikePolynomial
-
Getter for the required coefficient of the zernike polynomial.
- getCoefficients(Vector3D, AtmosphereData, Assembly) - Method in interface fr.cnes.sirius.patrius.assembly.models.DragCoefficientProvider
-
Provides drag coefficient (x surface).
- getCoefficients(Vector3D, AtmosphereData, Assembly) - Method in class fr.cnes.sirius.patrius.assembly.models.GlobalDragCoefficientProvider
-
- getCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the polynomial coefficients.
- getCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunction
-
Getter for the polynomial coefficients.
- getCoefficients() - Method in interface fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunctionInterface
-
Getter for the polynomial coefficients.
- getCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialChebyshevFunction
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunction
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in interface fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionInterface
-
Get the polynomial coefficients.
- getCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.AbstractPolynomialSolver
-
- getCoefficients() - Method in class fr.cnes.sirius.patrius.math.optim.linear.LinearConstraint
-
Gets the coefficients of the constraint (left hand side).
- getCoefficients() - Method in class fr.cnes.sirius.patrius.math.optim.linear.LinearObjectiveFunction
-
Gets the coefficients of the linear equation being optimized.
- getCoefficients() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoefReader
-
Getter for the loaded coefficients.
- getCoefficientsProvider() - Static method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsFactory
-
Get the ocean tides coefficients provider from the first supported file.
- getCoefS() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefS
- getCoefSCos1A() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefSCos1A
- getCoefSCos2A() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefSCos2A
- getCoefSDrift() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefSDrift
- getCoefSSin1A() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefSSin1A
- getCoefSSin2A() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for normalized coefSSin2A
- getColumn(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Get the entries in column number col as an array.
- getColumn(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the entries of a given column.
- getColumn(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Get the entries in column number col as an array.
- getColumn(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Gets the entries of a given column.
- getColumn(int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the entries of a given column.
- getColumn(int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Get the entries in column number col as an array.
- getColumn() - Method in exception fr.cnes.sirius.patrius.math.linear.NonPositiveDefiniteMatrixException
-
- getColumn() - Method in exception fr.cnes.sirius.patrius.math.linear.NonSymmetricMatrixException
-
- getColumn(int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the entries of a given column.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in interface fr.cnes.sirius.patrius.math.linear.AnyMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.JacobiPreconditioner
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class fr.cnes.sirius.patrius.math.linear.RealLinearOperator
-
Returns the dimension of the domain of this operator.
- getColumnMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Get the entries in column number column as a column matrix.
- getColumnMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the entries of a given column as a column matrix.
- getColumnMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets the entries of a given column as a column matrix.
- getColumnMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Get the entries in column number column as a column matrix.
- getColumnMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Gets the entries of a given column as a column matrix.
- getColumnMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the entries of a given column as a column matrix.
- getColumnMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the entries of a given column as a column matrix.
- getColumnMatrix(int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Get the entries in column number column as a column matrix.
- getColumnMatrix(int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the entries of a given column as a column matrix.
- getColumnPermutationIndexArray(AnyMatrix, int[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Builds a column permutation index array for a given matrix, starting with the preselected
columns.
- getColumnSeparator() - Method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Get the format separator between components.
- getColumnVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Returns the entries in column number column as a vector.
- getColumnVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the entries of a given column as a vector.
- getColumnVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Returns the entries in column number column as a vector.
- getColumnVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Gets the entries of a given column as a vector.
- getColumnVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the entries of a given column as a vector.
- getColumnVector(int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Returns the entries in column number column as a vector.
- getColumnVector(int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the entries of a given column as a vector.
- getCombinerLoss() - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
-
Returns loss due to the combiner of the antenna [dB].
- getComment() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEvent
-
- getComment() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Phenomenon
-
- getCompensation(PVCoordinatesProvider, AbsoluteDate, Frame, Attitude) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointingWrapper
-
Compute the TimeStampedAngularCoordinates at a given time.
- getCompensation(PVCoordinatesProvider, AbsoluteDate, Frame, Attitude) - Method in class fr.cnes.sirius.patrius.attitudes.YawCompensation
-
Compute the TimeStampedAngularCoordinates at a given time.
- getCompensation(PVCoordinatesProvider, AbsoluteDate, Frame, Attitude) - Method in class fr.cnes.sirius.patrius.attitudes.YawSteering
-
Compute the TimeStampedAngularCoordinates at a given time.
- getCompiler(int, int) - Static method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Get the compiler for number of free parameters and order.
- getCompIndirection() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Returns indirection arrays for function composition.
- getComplement(Region<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.RegionFactory
-
Get the complement of the region (exchanged interior/exterior).
- getComplementaryFieldOfView() - Method in class fr.cnes.sirius.patrius.fieldsofview.PyramidalField
-
Build the complementary field of view of this.
- getComplementaryIntervals() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateIntervalsList
-
Gets the list of complementary intervals of the given list of intervals.
- getCompleteState() - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get the complete current state.
- getComponents() - Method in class fr.cnes.sirius.patrius.math.distribution.MixtureMultivariateRealDistribution
-
Gets the distributions that make up the mixture model.
- getComponents() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.OrderedTuple
-
Get the components array.
- getComponents(TimeScale) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Split the instance into date/time components.
- getConditionNumber() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Return the condition number of the matrix.
- getConditionNumberRange(RealMatrix, int) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.AlgebraUtils
-
Returns a lower and an upper bound for the condition number
kp(A) = Norm[A, p] / Norm[A^-1, p]
where
Norm[A, p] = sup ( Norm[A.x, p]/Norm[x, p] , x !
- getConfiguration() - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationBuilder
-
Configuration builder using the current builder providers.
- getConfiguration() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Getter for the current configuration.
- getConjugate() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Returns the conjugate quaternion of the instance.
- getConjugateRadius() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
- getConjugateRadius() - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
- getConjugateRadius() - Method in class fr.cnes.sirius.patrius.bodies.ThreeAxisEllipsoid
-
- getConstant() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
- getConstantDragCoef() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.AerodynamicProperties
-
Get the drag coefficient.
- getConstantLiftCoef() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.AerodynamicProperties
-
Get the lift coefficient.
- getConstants() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesHarmonicProfile
-
Gets the a0 coefficients of the three Fourier series representing x, y and z.
- getConstants() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
- getConstantTerm() - Method in class fr.cnes.sirius.patrius.math.optim.linear.LinearObjectiveFunction
-
Gets the constant of the linear equation being optimized.
- getConstraintContinuous() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
-
Get the time constraint for continuous maneuvers.
- getConstraintImpulsive() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
-
Get the time constraint for impulsive maneuvers.
- getConstraints() - Method in class fr.cnes.sirius.patrius.math.optim.linear.LinearConstraintSet
-
Gets the set of linear constraints.
- getConstraints() - Method in class fr.cnes.sirius.patrius.math.optim.linear.LinearOptimizer
-
- getContentSummaryRecord(int, int, int, int, boolean[]) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.ReadDoublePrecisionDAF
-
Read a portion of the contents of a summary record in a DAF file.
- getContext() - Method in exception fr.cnes.sirius.patrius.math.exception.MathArithmeticException
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContext() - Method in exception fr.cnes.sirius.patrius.math.exception.MathIllegalArgumentException
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContext() - Method in exception fr.cnes.sirius.patrius.math.exception.MathIllegalStateException
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContext() - Method in exception fr.cnes.sirius.patrius.math.exception.MathRuntimeException
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContext() - Method in exception fr.cnes.sirius.patrius.math.exception.MathUnsupportedOperationException
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContext() - Method in interface fr.cnes.sirius.patrius.math.exception.util.ExceptionContextProvider
-
Gets a reference to the "rich context" data structure that allows to
customize error messages and store key, value pairs in exceptions.
- getContinueManeuversList() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
-
Get the continue maneuvers list.
- getContour() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FieldData
-
Getter for the contour of the visible surface on the body.
- getContractionCriterion() - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
The contraction criterion defines when the internal array will contract
to store only the number of elements in the element array.
- getControlMatrix() - Method in class fr.cnes.sirius.patrius.math.filter.DefaultProcessModel
-
Returns the control matrix.
- getControlMatrix() - Method in interface fr.cnes.sirius.patrius.math.filter.ProcessModel
-
Returns the control matrix.
- getConvention() - Method in class fr.cnes.sirius.patrius.bodies.bsp.BSPEphemerisLoader
-
Getter for the Spice J2000 convention.
- getConvention() - Method in class fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecession
-
Returns the IAU convention.
- getConvention() - Method in class fr.cnes.sirius.patrius.math.utils.AbstractSearchIndex
-
Returns the convention that can be applied to the interval during the search index algorithm.
- getConvention() - Method in interface fr.cnes.sirius.patrius.math.utils.ISearchIndex
-
Returns the convention that can be applied to the interval during the search index algorithm.
- getConvergence() - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Get the convergence threshold for event localization.
- getConvergenceChecker() - Method in class fr.cnes.sirius.patrius.math.optim.BaseOptimizer
-
Gets the convergence checker.
- getCoordinate() - Method in class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
Returns the coordinate of this entry.
- getCoordinates(Vector3D) - Method in interface fr.cnes.sirius.patrius.forces.gravity.grid.GridSystem
-
Returns coordinates in grid system for provided position.
- getCoordinateSystem() - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
Returns the coordinate system of the entries in this orbit file.
- getCoordinateSystem() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the coordinate system of the entries in this orbit file.
- getCoordinateType(int, PositionAngle) - Method in enum fr.cnes.sirius.patrius.orbits.OrbitType
-
Gets the coordinate type associated with a given state vector index.
- getCoriolisRelativisticEffect() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getCorners() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
- getCorrectedVector(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractStationToSatDetector
-
Compute the apparent vector from the station to the spacecraft with tropospheric effects.
- getCorrection() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractStationToSatDetector
-
Get the correction.
- getCorrectionModel(MeteorologicalConditionsProvider, BodyPoint) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AbstractMeteoBasedCorrectionFactory
-
Getter for a meteorologically based correction model.
- getCorrectionsFromApparentElevation(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AzoulayModel
-
Computes the corrections due to the troposphere from the apparent value of the elevation at a given date.
- getCorrectionsFromGeometricElevation(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AzoulayModel
-
Computes the corrections due to the troposphere from the geometric value of the elevation at a given date.
- getCorrelationCoefficient(int, int) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the correlation coefficient ρi,j for the specified row and column
indexes.
- getCorrelationCoefficient(ParameterDescriptor, ParameterDescriptor) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the correlation coefficient ρi,j associated with the specified parameter
descriptors, the first parameter* descriptor being mapped to the rows of the covariance
matrix (index "i"), while the second parameter descriptor is mapped to the columns of the
covariance matrix (index "j").
- getCorrelationCoefficientsMatrix() - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the correlation matrix.
- getCorrelationMatrix() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.PearsonsCorrelation
-
Returns the correlation matrix
- getCorrelationMatrix() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.SpearmansCorrelation
-
Calculate the Spearman Rank Correlation Matrix.
- getCorrelationPValues() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.PearsonsCorrelation
-
Returns a matrix of p-values associated with the (two-sided) null
hypothesis that the corresponding correlation coefficient is zero.
- getCorrelationStandardErrors() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.PearsonsCorrelation
-
Returns a matrix of standard errors associated with the estimates
in the correlation matrix.
- getCosArray() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
- getCosArrays() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesHarmonicProfile
-
Gets the a coefficients of the three Fourier series representing x, y and z.
- getCosArrays() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
- getCount(Comparable<?>) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the number of values = v.
- getCount(int) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the number of values = v.
- getCount(long) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the number of values = v.
- getCount(char) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the number of values = v.
- getCount() - Method in class fr.cnes.sirius.patrius.math.util.Incrementor
-
Gets the current count.
- getCount(int...) - Method in class fr.cnes.sirius.patrius.math.util.MultidimensionalCounter
-
Convert to unidimensional counter.
- getCount() - Method in class fr.cnes.sirius.patrius.math.util.MultidimensionalCounter.Iterator
-
Get the current unidimensional counter slot.
- getCount(int) - Method in class fr.cnes.sirius.patrius.math.util.MultidimensionalCounter.Iterator
-
Get the current count in the selected dimension.
- getCounts(int) - Method in class fr.cnes.sirius.patrius.math.util.MultidimensionalCounter
-
Convert to multidimensional counter.
- getCounts() - Method in class fr.cnes.sirius.patrius.math.util.MultidimensionalCounter.Iterator
-
Get the current multidimensional counter slots.
- getCovariance() - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Gets the covariance.
- getCovariance(double) - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Returns the n × n covariance matrix.
- getCovariance(int, int) - Method in class fr.cnes.sirius.patrius.math.stat.correlation.StorelessCovariance
-
Get the covariance for an individual element of the covariance matrix.
- getCovariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the covariance matrix of the values that have been added.
- getCovariance() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns the covariance of the available values.
- getCovariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the covariance matrix of the values that have been added.
- getCovarianceMatrix() - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Gets the covariance matrix.
- getCovarianceMatrix() - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the covariance matrix.
- getCovarianceMatrix() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Returns the covariance matrix
- getCovarianceMatrix() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.StorelessCovariance
-
Returns the covariance matrix
- getCovarianceMatrix3x3(Vector3D) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.GatesModel
-
Computes the covariance matrix modeling the uncertainty on a maneuver's magnitude and
direction.
- getCovarianceMatrix3x3(Vector3D, double, double) - Static method in class fr.cnes.sirius.patrius.forces.maneuvers.GatesModel
-
Computes the covariance matrix modeling the uncertainty on a maneuver's magnitude and
direction.
- getCovarianceMatrix6x6(Vector3D) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.GatesModel
-
Computes the covariance matrix modeling the uncertainty on an object's position and velocity
induced by the uncertainty on a maneuver's magnitude and direction.
- getCovarianceMatrix6x6(Vector3D, double, double) - Static method in class fr.cnes.sirius.patrius.forces.maneuvers.GatesModel
-
Computes the covariance matrix modeling the uncertainty on an object's position and velocity
induced by the uncertainty on a maneuver's magnitude and direction.
- getCovarianceOfParameters(int, int) - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
Returns the covariance between regression parameters i and j.
- getCovariances() - Method in class fr.cnes.sirius.patrius.math.distribution.MultivariateNormalDistribution
-
Gets the covariance matrix.
- getCp() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getCpmEpm(double, int, int) - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
-
Get the Clm± and εlm± for given wave
- getCpmEpm(double, int, int) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
-
Get the Clm± and εlm± for given wave
- getCpmEpm(double, int, int) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTidesDataProvider
-
Get the Clm± and εlm± for given wave
- getCpmSpm(double, int, int) - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
-
Get the Clm± and Slm± for given wave
- getCpmSpm(double, int, int) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
-
Get the Clm± and Slm± for given wave
- getCpmSpm(double, int, int) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTidesDataProvider
-
Get the Clm± and Slm± for given wave
- getCRadius() - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Getter for the semi axis C.
- getCRadius() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Getter for the semi axis C.
- getCrc() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getCrossoverPoints() - Method in class fr.cnes.sirius.patrius.math.genetics.NPointCrossover
-
- getCrossoverPolicy() - Method in class fr.cnes.sirius.patrius.math.genetics.GeneticAlgorithm
-
Returns the crossover policy.
- getCrossoverRate() - Method in class fr.cnes.sirius.patrius.math.genetics.GeneticAlgorithm
-
Returns the crossover rate.
- getCrossSection(SpacecraftState, Vector3D, Frame, Frame) - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroCrossSectionProperty
-
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
-
- getCrossSection(SpacecraftState, Vector3D, Frame, Frame) - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
-
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.properties.CrossSectionProviderProperty
-
Computes the cross section of the geometry from a direction
defined by a Vector3D.
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.properties.features.Facet
-
Computes the cross section from the direction
defined by a Vector3D.
- getCrossSection(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeCrossSectionProperty
-
- getCrossSection(SpacecraftState, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeSphereProperty
-
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.vehicle.VehicleSurfaceModel
-
Computes the cross section from the direction
defined by a Vector3D.
- getCrossSection(Vector3D) - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.CrossSectionProvider
-
Computes the cross section from the direction
defined by a Vector3D.
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
Computes the cross section from the direction
defined by a Vector3D.
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
Computes the cross section from the direction
defined by a Vector3D.
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
Computes the cross section from the direction
defined by a Vector3D.
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularSurfaceCylinder
-
Computes the cross section from the direction
defined by a Vector3D.
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Computes the cross section from the direction
defined by a Vector3D.
- getCrossSection(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Computes the cross section from the direction
defined by a Vector3D.
- getCrs() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getCsm() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getCsp() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getCuc() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getCumFreq(Comparable<?>) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumFreq(int) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumFreq(long) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumFreq(char) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumPct(Comparable<?>) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCumPct(int) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCumPct(long) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCumPct(char) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCumulatedIntegration() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.FixedStepSimpsonIntegrator
-
Returns cumulated integration data (specific to COLOSUS).
- getCunningham(EarthGravitationalModelFactory.GravityFieldNames, String, int, int, boolean) - Static method in class fr.cnes.sirius.patrius.forces.gravity.EarthGravitationalModelFactory
-
Create an instance of the gravitational field of a celestial body using Cunningham model and specific data.
- getCurrentDate() - Method in class fr.cnes.sirius.patrius.propagation.sampling.AdaptedStepHandler
-
Get the current grid date.
- getCurrentDate() - Method in class fr.cnes.sirius.patrius.propagation.sampling.BasicStepInterpolator
-
Get the current grid date.
- getCurrentDate() - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
-
Get the current grid date.
- getCurrentDate() - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiPatriusStepInterpolator
-
Get the current grid date.
- getCurrentDate() - Method in interface fr.cnes.sirius.patrius.propagation.sampling.PatriusStepInterpolator
-
Get the current grid date.
- getCurrentDate() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
-
Get the current grid date.
- getCurrentMainSetJacobian(double[][]) - Method in class fr.cnes.sirius.patrius.math.ode.JacobianMatrices
-
Get the current value of the Jacobian matrix with respect to state.
- getCurrentOccurrence() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get the current occurrence (during propagation).
- getCurrentParameterJacobian(String, double[]) - Method in class fr.cnes.sirius.patrius.math.ode.JacobianMatrices
-
Get the current value of the Jacobian matrix with respect to one parameter.
- getCurrentSignedStepsize() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Get the current signed value of the integration stepsize.
- getCurrentSignedStepsize() - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Get the current signed value of the integration stepsize.
- getCurrentState() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.cowell.CowellIntegrator
-
Returns integrator current state.
- getCurrentStepStart() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Get the current value of the step start time ti.
- getCurrentStepStart() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Get the current value of the step start time ti.
- getCurrentStepStart() - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Get the current value of the step start time ti.
- getCurrentTime() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Get the current soft grid point time.
- getCurrentTime() - Method in interface fr.cnes.sirius.patrius.math.ode.sampling.StepInterpolator
-
Get the current grid point time.
- getCurrentUsableInterval() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Getter for the current usable interval of the ephemeris.
- getCus() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getCut() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BSPTree
-
Get the cut sub-hyperplane.
- getCx() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the parametereziable function for the Ax coefficient.
- getCy() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the parametereziable function for the Cy coefficient.
- getCz() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the parametereziable function for the Cz coefficient.
- getD() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean elongation of the Moon from the Sun.
- getD() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Output
-
Getter for density (d).
- getD(int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Output
-
Getter for density component.
- getD() - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Gets the block diagonal matrix D of the decomposition.
- getD() - Method in interface fr.cnes.sirius.patrius.math.linear.UDDecomposition
-
Returns the matrix D of the decomposition.
- getD() - Method in class fr.cnes.sirius.patrius.math.linear.UDDecompositionImpl
-
get the D matrix
- getDa() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.orbman.ImpulseDaManeuver
-
Getter for semi-major axis increment.
- getDa() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.orbman.ImpulseDeManeuver
-
Getter for semi-major axis increment.
- getDa() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.orbman.ImpulseDiManeuver
-
Getter for semi-major axis increment.
- getData(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Get detailed atmospheric data.
- getData(AbsoluteDate, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.ExtendedAtmosphere
-
Get detailed atmospheric data.
- getData(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
Get detailed atmospheric data.
- getData() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionData
-
Returns the attraction data points.
- getData() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.CartesianGridAttractionLoader
-
Returns the read data.
- getData() - Method in interface fr.cnes.sirius.patrius.forces.gravity.grid.GridAttractionProvider
-
Returns the read data.
- getData() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.SphericalGridAttractionLoader
-
Returns the read data.
- getData() - Method in interface fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
-
Get the normalized variable potential coefficients
- getData() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
Get the normalized variable potential coefficients
- getData() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Matrix3D
-
- getData() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns a 2D array containing the entries of the matrix.
- getData(boolean) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns a 2D array containing the entries of the matrix.
- getData() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Returns a 2D array containing the entries of the matrix.
- getData(boolean) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Returns a 2D array containing the entries of the matrix.
- getData() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Returns the vector data (copy).
- getData() - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Returns a 2D array containing the entries of the matrix.
- getData() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns a 2D array containing the entries of the matrix.
- getData() - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns a 2D array containing the entries of the matrix.
- getData(boolean) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns a 2D array containing the entries of the matrix.
- getData() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.StorelessCovariance
-
Return the covariance matrix as two-dimensional array.
- getData() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AbstractUnivariateStatistic
-
Get a copy of the stored data array.
- getData(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.ionosphere.USKLoader
-
Returns the USK data for the Bent model.
- getData(AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.ionosphere.USKProvider
-
Returns the USK data for the Bent model.
- getData(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
Getter for the atmospheric model output container.
- getData() - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Getter for the data associated to the
intervals.
- getData(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Getter for the object associated to the provided date.
- getData(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Getter for the object associated to the provided date.
- getDataAsArray() - Method in interface fr.cnes.sirius.patrius.tools.parallel.ParallelResult
-
Gets the result data as an array of arrays.
- getDataLocation() - Method in enum fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationConvention
-
Get the location of the data for the selected convention.
- getDataRef() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Get a reference to the underlying data array.
- getDataRef() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Gets a direct reference to the underlying data array storing the entries of the matrix.
- getDataRef() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Returns a reference to the underlying data array.
- getDataRef() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Get a reference to the underlying data array.
- getDataRef() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets a reference to the internal data array storing the lower part of the symmetric matrix.
- getDataRef() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets a reference to the internal data array storing the diagonal elements of the matrix.
- getDataRef() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AbstractUnivariateStatistic
-
Get a reference to the stored data array.
- getDataType(String) - Static method in enum fr.cnes.sirius.patrius.bodies.mesh.ObjMeshLoader.DataType
-
Getter for the type of data corresponding to the code.
- getDataUsed() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the data used indicator from the SP3 file.
- getDate() - Method in class fr.cnes.sirius.patrius.attitudes.Attitude
-
Get the date of attitude parameters.
- getDate() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.TimeStampedRotation
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FieldData
-
Getter for the date.
- getDate() - Method in class fr.cnes.sirius.patrius.bodies.PosVelChebyshev
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.covariance.MultiOrbitalCovariance
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.covariance.OrbitalCovariance
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.events.detectors.DateDetector
-
Get the current event date according to the propagator.
- getDate() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEvent
-
- getDate() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsLogger.LoggedCodedEvent
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiCodedEventsLogger.MultiLoggedCodedEvent
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
Get the date.
- getDate() - Method in interface fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
-
Get the reference date of the file
- getDate() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
- getDate() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.SmallManeuverAnalyticalModel
-
Get the date of the maneuver.
- getDate() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPEntry
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrection
-
- getDate() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the date of orbital parameters.
- getDate() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the TLE current date.
- getDate() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the date.
- getDate(VacuumSignalPropagation) - Method in enum fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation.SignalPropagationRole
-
Getter for the date associated to this role (transmission or reception date).
- getDate() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.time.DateTimeComponents
-
Get the date component.
- getDate() - Method in interface fr.cnes.sirius.patrius.time.TimeStamped
-
Get the date.
- getDate() - Method in interface fr.cnes.sirius.patrius.utils.legs.Leg
-
Returns the leg start date.
- getDate() - Method in class fr.cnes.sirius.patrius.utils.TimeStampedAngularCoordinates
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.utils.TimeStampedDouble
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.utils.TimeStampedPVCoordinates
-
Get the date.
- getDate() - Method in class fr.cnes.sirius.patrius.utils.TimeStampedString
-
Get the date.
- getDate1() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.Stela3StepsSolarActivity
-
Getter for the first date.
- getDate2() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.Stela3StepsSolarActivity
-
Getter for the second date.
- getDateIntervals() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.AbstractDateIntervalFunction
-
Returns a copy of date intervals.
- getDateListFromSize(int) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Returns a list of dates constructed from the interval evenly distributed in the interval.
- getDateListFromStep(double) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Returns a list of dates constructed from the interval, a date every step (in seconds).
- getDateRef() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractBoundedPVProvider
-
Getter for the reference date.
- getDateZero() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfileLeg
-
Get the date zero of the polynomial functions.
- getDay() - Method in class fr.cnes.sirius.patrius.time.DateComponents
-
Get the day.
- getDayFraction() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the day fraction for this SP3 file.
- getDayOfWeek() - Method in class fr.cnes.sirius.patrius.time.DateComponents
-
Get the day of week.
- getDayOfYear() - Method in class fr.cnes.sirius.patrius.time.DateComponents
-
Get the day number in year.
- getDAzimuth(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the azimuth derivative of a point wrt the local point (dAzimuth) express in the specified frame.
- getDdeps() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NutationCorrection
-
Get the δΔε1980 parameter.
- getDdpsi() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NutationCorrection
-
Get the δΔψ1980 parameter.
- getdDragdt() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Method that returns the drag value in memory, only used for n steps drag computation purposes
- getDe() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.orbman.ImpulseDeManeuver
-
Getter for eccentricity axis increment.
- getDecimalDigits() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpDec
-
Get the number of decimal digits this class is going to represent.
- getDecimalYear(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Utility function to get a decimal year for a given AbsoluteDate.
- getDecimalYear(int, int, int) - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Utility function to get a decimal year for a given day.
- getDeclination() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticElements
-
Returns the declination of the magnetic field in degrees.
- getDecreasingTimeShift() - Method in class fr.cnes.sirius.patrius.events.utils.EventShifter
-
Get the decreasing events time shift.
- getDefaultAbsolutePositivityThreshold() - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Gets the default absolute positivity threshold, above which a value is considered to be
strictly positive.
- getDefaultAbsoluteSymmetryThreshold() - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets the default absolute threshold above which off-diagonal elements are considered
different.
- getDefaultDecomposition() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the decomposition builder the
getInverse() method uses
by default when computing the inverse of the matrix.
- getDefaultDecomposition() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the decomposition builder the
getInverse() method uses
by default when computing the inverse of the matrix.
- getDefaultModel(double) - Static method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.FixedDelayModel
-
Returns the default model, loading delay values from the file "tropospheric-delay.txt".
- getDefaultNumberFormat() - Static method in class fr.cnes.sirius.patrius.math.fraction.AbstractFormat
-
Create a default number format.
- getDefaultNumberFormat(Locale) - Static method in class fr.cnes.sirius.patrius.math.fraction.AbstractFormat
-
Create a default number format.
- getDefaultNumberFormat() - Static method in class fr.cnes.sirius.patrius.math.fraction.FractionFormat
-
Create a default number format.
- getDefaultNumberFormat() - Static method in class fr.cnes.sirius.patrius.math.util.CompositeFormat
-
Create a default number format.
- getDefaultNumberFormat(Locale) - Static method in class fr.cnes.sirius.patrius.math.util.CompositeFormat
-
Create a default number format.
- getDefaultNumberFormat(Locale, int) - Static method in class fr.cnes.sirius.patrius.math.util.CompositeFormat
-
Create a default number format.
- getDefaultRelativePositivityThreshold() - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Gets the default relative positivity threshold, above which a value is considered to be
numerically significant when compared to another value.
- getDefaultRelativeSymmetryThreshold() - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets the default relative threshold above which off-diagonal elements are considered
different.
- getDegree() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getDegree() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
- getDegree() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the polynomial degree.
- getDegree() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunction
-
Getter for the polynomial degree.
- getDegree() - Method in interface fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunctionInterface
-
Getter for the polynomial degree.
- getDegree() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialChebyshevFunction
-
Returns the degree of the Chebyshev polynomial.
- getDegree() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunction
-
Returns the degree of the polynomial.
- getDegree() - Method in interface fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionInterface
-
Return the polynomial degree.
- getDegree() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialFunction
-
Get polynomial degree
- getDegreesOfFreedom() - Method in class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
Access the number of degrees of freedom.
- getDegreesOfFreedom() - Method in class fr.cnes.sirius.patrius.math.distribution.TDistribution
-
Access the degrees of freedom.
- getDElevation(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the elevation derivative of a point wrt the local point (dElevation) express in the specified frame.
- getDelta() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Get the elevation of the vector.
- getDelta() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCoordinates
-
Get the elevation δ.
- getDelta() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the elevation of the vector.
- getDelta0Coeffs() - Method in class fr.cnes.sirius.patrius.bodies.IAUPoleCoefficients
-
Returns the coefficients for δ0 component.
- getDeltaEccentricity() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for the delta eccentricity Δe.
- getDeltaN() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getDeltaNRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getDeltaVSat() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get the velocity increment in satellite frame.
- getDenominator() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Access the denominator as a BigInteger.
- getDenominator() - Method in class fr.cnes.sirius.patrius.math.fraction.Fraction
-
Access the denominator.
- getDenominatorAsInt() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Access the denominator as a int.
- getDenominatorAsLong() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Access the denominator as a long.
- getDenominatorDegreesOfFreedom() - Method in class fr.cnes.sirius.patrius.math.distribution.FDistribution
-
Access the denominator degrees of freedom.
- getDenominatorFormat() - Method in class fr.cnes.sirius.patrius.math.fraction.AbstractFormat
-
Access the denominator format.
- getDenormalizedCCoefs(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTides
-
Get denormalized C coefficients table
- getDenormalizedSCoefs(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTides
-
Get denormalized S coefficients table
- getDensity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Getter for the local density.
- getDensity(AbsoluteDate, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.Atmosphere
-
Get the local density.
- getDensity() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the total density.
- getDensity(double, double, Vector3D, double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.HarrisPriester
-
Getter for the local density.
- getDensity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.HarrisPriester
-
Getter for the local density.
- getDensity(double, double, double, double, double, double, double, double, double, double, double, double, double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.JB2006
-
Get the local density with initial entries.
- getDensity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.JB2006
-
Get the local density.
- getDensity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
Get the local density.
- getDensity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
Get the local density.
- getDensity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.US76
-
Getter for the local density for altitude in interval [0, 1E6]m.
- getDensity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
Getter for the density at the local point.
- getDensity() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.JacchiaOutput
-
Getter for the atmospheric density.
- getDensityAnomalousOxygen() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the anomalous oxygen density.
- getDensityAr() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the Argon density.
- getDensityH() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the hydrogen density.
- getDensityHe() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Return the Helium density.
- getDensityN() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the nitrogen density.
- getDensityN2() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the dinitrogen density.
- getDensityO() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the Oxygen density.
- getDensityO2() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the dioxygen density.
- getDepth() - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the depth of the frame.
- getDerivatives(StelaForceModel) - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
-
Returns derivative dE'/dt (E' = mean orbital parameters) for provided force model.
- getDerivatives() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaPartialDerivativesEquations
-
Returns derivatives map .
- getDerivativesSTM(StelaForceModel) - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
-
Returns derivative dSTM/dt (STM = state transition matrix) for provided force model.
- getDescription() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkSegment
-
// Check for null input the descriptor of the segment.
- getDescriptor() - Method in class fr.cnes.sirius.patrius.math.parameter.Parameter
-
Gets the parameter descriptor.
- getDetector() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsLogger.LoggedCodedEvent
-
- getDetector() - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedEventDetector
-
Get the detector object.
- getDetector1() - Method in class fr.cnes.sirius.patrius.events.detectors.CombinedPhenomenaDetector
-
Returns first detector.
- getDetector2() - Method in class fr.cnes.sirius.patrius.events.detectors.CombinedPhenomenaDetector
-
Returns second detector.
- getDeterminant() - Method in class fr.cnes.sirius.patrius.math.linear.CholeskyDecomposition
-
Return the determinant of the matrix
- getDeterminant() - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Computes the determinant of the matrix.
- getDeterminant() - Method in class fr.cnes.sirius.patrius.math.linear.FieldLUDecomposition
-
Return the determinant of the matrix.
- getDeterminant() - Method in class fr.cnes.sirius.patrius.math.linear.LUDecomposition
-
Return the determinant of the matrix
- getDeterminant() - Method in interface fr.cnes.sirius.patrius.math.linear.UDDecomposition
-
Return the determinant of the matrix
- getDeterminant() - Method in class fr.cnes.sirius.patrius.math.linear.UDDecompositionImpl
-
get the determinant
- getDevelopmentOrders() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Return the array with models trigonometric orders.
- getDH() - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Getter for the finite difference delta value.
- getDi() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.orbman.ImpulseDiManeuver
-
Getter for inclination increment.
- getDiagonal() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the diagonal vector from this matrix.
- getDiagonal() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the diagonal vector from this matrix.
- getDiagonal() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the diagonal vector from this matrix.
- getDiagonal() - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Gets the diagonal vector from this matrix.
- getDiagonalLength() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.UpperDiagonalHKKTSolver
-
Get diagonal length
- getDiagonalOfHatMatrix(double[]) - Method in class fr.cnes.sirius.patrius.math.stat.regression.MillerUpdatingRegression
-
Gets the diagonal of the Hat matrix also known as the leverage matrix.
- getDifferentiator() - Method in class fr.cnes.sirius.patrius.attitudes.kinematics.AbstractOrientationFunction
-
Get the differentiator.
- getDifferentiator() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractVector3DFunction
-
Get the differentiator.
- getDiffTaylorCoeffs() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for the Taylor coefficients (up to the 2nd order) of the eccentricity function derivative G'(e).
- getDiffuseReflectionCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
-
Get the parameter representing the diffuse reflection coefficient of the part.
- getDiffuseReflectionRatio() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
-
Get the parameter representing the ratio of light subjected to diffuse reflectance : Kd = (1
- α) (1 - τ).
- getDim() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.functions.LogarithmicBarrier
-
Get dimension
- getDim() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.functions.QuadraticMultivariateRealFunction
-
Get dimension
- getDim() - Method in interface fr.cnes.sirius.patrius.math.optim.joptimizer.functions.TwiceDifferentiableMultivariateRealFunction
-
Get dimension of the function argument.
- getDim() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the number of variables.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractMultivariateRealDistribution
-
Gets the number of random variables of the distribution.
- getDimension() - Method in interface fr.cnes.sirius.patrius.math.distribution.MultivariateRealDistribution
-
Gets the number of random variables of the distribution.
- getDimension() - Method in exception fr.cnes.sirius.patrius.math.exception.DimensionMismatchException
-
- getDimension() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Euclidean1D
-
Get the dimension of the space.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Euclidean3D
-
Get the dimension of the space.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Euclidean2D
-
Get the dimension of the space.
- getDimension() - Method in interface fr.cnes.sirius.patrius.math.geometry.Space
-
Get the dimension of the space.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Returns the size of the vector.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Returns the size of the vector.
- getDimension() - Method in interface fr.cnes.sirius.patrius.math.linear.FieldVector
-
Returns the size of the vector.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Returns the size of the vector.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.ode.EquationsMapper
-
Get the dimension of the secondary state parameters.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.ode.FirstOrderConverter
-
Get the dimension of the problem.
- getDimension() - Method in interface fr.cnes.sirius.patrius.math.ode.FirstOrderDifferentialEquations
-
Get the dimension of the problem.
- getDimension() - Method in interface fr.cnes.sirius.patrius.math.ode.SecondaryEquations
-
Get the dimension of the secondary state parameters.
- getDimension() - Method in interface fr.cnes.sirius.patrius.math.ode.SecondOrderDifferentialEquations
-
Get the dimension of the problem.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Get simplex dimension.
- getDimension() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the dimension of the data
- getDimension() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns the dimension of the data
- getDimension() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the dimension of the data
- getDimension() - Method in class fr.cnes.sirius.patrius.math.util.MultidimensionalCounter
-
Get the number of dimensions of the multidimensional counter.
- getDimension() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Compute complete state vector dimension.
- getDimension() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaDifferentialEquations
-
Get the dimension of the problem.
- getDirection(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the thrust direction.
- getDirection() - Method in exception fr.cnes.sirius.patrius.math.exception.NonMonotonicSequenceException
-
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCone
-
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCylinder
-
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
This method returns the main axis of the cylinder
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCylinder
-
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCylinder
-
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Get the normalized direction vector.
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.LineSegment
-
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RectangleCone
-
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCone
-
- getDirection() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
- getDirectionOne() - Method in class fr.cnes.sirius.patrius.frames.TwoDirectionFrame
-
- getDirectionTwo() - Method in class fr.cnes.sirius.patrius.frames.TwoDirectionFrame
-
- getDirFlux() - Method in class fr.cnes.sirius.patrius.forces.radiation.ElementaryFlux
-
get the direction flux
- getDistance() - Method in class fr.cnes.sirius.patrius.events.detectors.DistanceDetector
-
Returns the distance triggering the event.
- getDistance(BodyPoint) - Method in enum fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector.BodyDistanceType
-
Getter for the distance to the given point.
- getDistance(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Distance between two vectors.
- getDistance(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Distance between two vectors.
- getDistanceEpsilon() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
Return the distance epsilon below which the height coordinate is neglected.
- getDistanceEpsilon() - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Return the distance epsilon below which the height coordinate is neglected.
- getDistortionFactor(double) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
-
Getter for the scale factor at a specific latitude.
- getDistortionFactor(double) - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
-
Getter for the scale factor at a specific latitude.
- getDistortionFactor(double) - Method in class fr.cnes.sirius.patrius.projections.Mercator
-
Getter for the scale factor at a specific latitude.
- getDiurnalRotationModel() - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Get the diurnal rotation model.
- getDiurnalRotationModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Get the diurnal rotation model.
- getDnonInertial() - Method in class fr.cnes.sirius.patrius.stela.propagation.ForcesStepHandler
-
Getter for non-inertial contribution.
- getDoodson() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getDoodsonNumbers() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
-
Get available Doodson numbers
- getDoodsonNumbers() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
-
Get available Doodson numbers
- getDoodsonNumbers() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.ITerrestrialTidesDataProvider
-
Get the Doodson numbers used by the standard.
- getDoodsonNumbers() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTidesDataProvider
-
Get available Doodson numbers
- getDoodsonNumbers() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.TerrestrialTidesDataProvider
-
Get the Doodson numbers used by the standard.
- getDouble() - Method in class fr.cnes.sirius.patrius.utils.TimeStampedDouble
-
Getter for the double attached to the date.
- getDoubleMachineEpsilon() - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.util.Utils
-
The smallest positive (epsilon) such that 1.0 + epsilon !
- getDoubles() - Method in class fr.cnes.sirius.patrius.utils.TimeStampedDouble
-
Getter for the array of doubles.
- getDoy() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for doy.
- getdPert() - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaGaussContribution
-
- getdPot() - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaLagrangeContribution
-
- getDpph() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.HelmholtzPolynomial
-
Get the H'lm coefficients
- getdPropdPem(Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getdPropdPem() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the propagation position vector derivatives wrt the emitter position express in
the reference frame.
- getdPropDPos(VacuumSignalPropagation) - Method in enum fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation.SignalPropagationRole
-
Getter for the propagation vector (from antenna to space object) partial derivatives matrix wrt the space
object position in the reference frame at the emission or reception date depending on the SignalDirection
value.
- getdPropdPrec(Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getdPropdPrec() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the propagation position vector derivatives wrt the receiver position express in
the reference frame.
- getdPropdT(Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getdPropdT() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the propagation velocity vector (= propagation vector derivative wrt time) in the
reference frame.
- getDragArea() - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Gets the drag area of the object.
- getDragCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
-
Get the drag coefficient.
- getDragCoef() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.AerodynamicProperties
-
Get the drag coefficient.
- getDragCoef(StelaDragCoefInput) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.AbstractStelaDragCoef
-
Get the drag coefficient value.
- getDragCoef(StelaDragCoefInput) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaConstantDragCoef
-
Get the drag coefficient value.
- getDragCoef(StelaDragCoefInput) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDispersedDragCoef
-
Get the drag coefficient value.
- getDragCoef(StelaDragCoefInput) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDragCoef
-
Get the drag coefficient value.
- getDragCoef(StelaDragCoefInput) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDispersedDragCoef
-
Compute the value of the Cd coefficient depending on spacecraft altitude and the dispersed coefficient.
- getDragCoef(StelaDragCoefInput) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoef
-
Compute the value of the Cd coefficient depending on spacecraft altitude.
- getDragCoef() - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Gets the drag coefficient associated with the object.
- getDragCoefType() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.AbstractStelaDragCoef
-
Get the drag coefficient type.
- getDragForce() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroCrossSectionProperty
-
Get the drag force coefficient parametrizable function.
- getDragForce() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getDragForceDerivativeValue(Parameter, SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroCrossSectionProperty
-
Get the drag force coefficient derivative value with respect to the given parameter.
- getDragRecomputeStep() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAtmosphericDrag
-
- getDroziner(EarthGravitationalModelFactory.GravityFieldNames, String, int, int, boolean) - Static method in class fr.cnes.sirius.patrius.forces.gravity.EarthGravitationalModelFactory
-
Create an instance of the gravitational field of a celestial body using Droziner model and specific data.
- getDryMass() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Returns dry mass.
- getDsph() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.HelmholtzPolynomial
-
Get the H''lm coefficients
- getdTpropdPem() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the signal propagation partial derivatives vector wrt the emitter position in the
reference frame at the emitting date.
- getdTpropdPem(Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getdTPropDPos(VacuumSignalPropagation) - Method in enum fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation.SignalPropagationRole
-
Getter for the propagation time partial derivatives vector wrt the space object position in the reference
frame at the emission or reception date depending on the SignalDirection value.
- getdTpropdPrec() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the signal propagation partial derivatives vector wrt the receiver position in the
reference frame at the reception date.
- getdTpropdPrec(Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getdTpropdT() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the signal propagation partial derivatives wrt time.
- getDualityGap(double) - Method in interface fr.cnes.sirius.patrius.math.optim.joptimizer.functions.BarrierFunction
-
Calculates the duality gap for a barrier method build with this barrier function.
- getDualityGap(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.functions.LogarithmicBarrier
-
Calculates the duality gap for a barrier method build with this barrier function
- getDuplicates(LebedevGrid, double) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGrid
-
Returns the grid points of the given grid that are also contained in the current grid.
- getDuplicates(List<LebedevGridPoint>, double) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGrid
-
Returns the grid points of the given list that are also contained in the current grid.
- getDuration() - Method in class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
- getDuration() - Method in class fr.cnes.sirius.patrius.attitudes.slew.IsisSpinBiasSlewComputer
-
Getter for the duration of the slew
- getDuration() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Computes the interval duration (its length) in seconds.
- getDurations() - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Getter for the durations.
- getDX() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPEntry
-
Get the dx correction of the X component of the celestial pole (IAU 2000) or celestial pole offset in longitude
(IAU 1980).
- getDX() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NutationCorrection
-
Get the δX2000 parameter (radians).
- getDXangleCardan(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the Cardan x angle derivative of a point wrt the local point (dXangleCardan) express in the specified
frame.
- getDY() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPEntry
-
Get the dy correction of the Y component of the celestial pole (IAU 2000) or celestial pole offset in obliquity
(IAU 1980).
- getDY() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NutationCorrection
-
Get the δY2000 parameter (radians).
- getDYangleCardan(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the Cardan y angle derivative of a point wrt the local point (dYangleCardan) express in the specified
frame.
- getE() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant e.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the eccentricity.
- getE() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the eccentricity.
- getE2() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
- getE2() - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
Getter for the e2 (eccentricity e squared with e = f * (2.0 - f)).
- getE2() - Method in class fr.cnes.sirius.patrius.bodies.ThreeAxisEllipsoid
-
- getEarliest() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the earliest cached entry.
- getEarth() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Earth singleton body.
- getEarth() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Getter for the earth body shape.
- getEarthBody() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
Getter for the earth body.
- getEarthBody() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.US76
-
Getter for the earth body.
- getEarthBody() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
Getter for the earth body.
- getEarthMoonBarycenter() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Earth-Moon barycenter singleton bodies pair.
- getEarthObliquity(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Getter for the Earth obliquity at provided date used in MOD to Ecliptic MOD transformation.
- getEarthObliquity(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Getter for the Earth obliquity at provided date used in MOD to Ecliptic MOD transformation.
- getEarthObliquity(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecession
-
Getter for the Earth obliquity at provided date used in MOD to Ecliptic MOD transformation.
- getEarthObliquity(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.modprecession.MODPrecessionModel
-
Getter for the Earth obliquity at provided date used in MOD to Ecliptic MOD transformation.
- getEarthPotentialAttractionModel() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getEarthRadius() - Method in class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
-
Get the earth radius.
- getEarthRotationAngle(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.frames.transformations.TIRFProvider
-
Get the Earth Rotation Angle at the current date.
- getEarthRotationRate() - Static method in class fr.cnes.sirius.patrius.frames.transformations.TIRFProvider
-
Get the Earth Rotation rate.
- getEarthRotationRate() - Method in enum fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSType
-
- getEarthShape() - Method in class fr.cnes.sirius.patrius.events.detectors.LatitudeDetector
-
Getter for the Earth shape.
- getEast() - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the east direction of topocentric frame, expressed in the body frame of body shape to which the frame
center point is attached.
- getEccentricAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the eccentric anomaly.
- getEccentricAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the eccentric anomaly.
- getEccentricAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Get the eccentric anomaly.
- getEccentricAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Get the eccentric anomaly.
- getEccentricity() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getEccentricity(OneAxisEllipsoid) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Getter for the eccentricity.
- getEclipseDetector() - Method in class fr.cnes.sirius.patrius.events.detectors.CentralBodyMaskCircularFOVDetector
-
Get the eclipse detector.
- getEclipticJ2000() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
Get an Ecliptic J200, celestial point centered frame.
- getEclipticJ2000() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialPoint
-
Get an Ecliptic J200, celestial point centered frame.
- getEclipticJ2000() - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Get an Ecliptic J200, celestial point centered frame.
- getEclipticJ2000() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
This class implements the Ecliptic J2000 frame.
- getEclipticMOD(boolean) - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
This class implements the Ecliptic MOD frame (mean ecliptic and equinox of the epoch) (formerly called EOD).
- getEdges() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getEffectiveTolerance(Double, Double, double) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Gets the effective tolerance from a given absolute and relative tolerance.
- getEffects() - Method in class fr.cnes.sirius.patrius.propagation.analytical.AdapterPropagator
-
Get the differential effects.
- getEigenvector(int) - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Gets a copy of the ith eigenvector of the original matrix.
- getElement() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.AVLTree.Node
-
Get the contained element.
- getElement(int) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the element at the specified index
- getElement(int) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the element at the specified index
- getElement(int) - Method in interface fr.cnes.sirius.patrius.math.util.DoubleArray
-
Returns the element at the specified index.
- getElement(int) - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Returns the element at the specified index
- getElementNumber() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the element number.
- getElements() - Method in interface fr.cnes.sirius.patrius.math.util.DoubleArray
-
Returns a double[] array containing the elements of this DoubleArray.
- getElements() - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Returns a double array containing the elements of this ResizableArray.
- getElevation() - Method in class fr.cnes.sirius.patrius.events.detectors.ApparentElevationDetector
-
Get the threshold apparent elevation value.
- getElevation() - Method in class fr.cnes.sirius.patrius.events.detectors.ElevationDetector
-
Get the threshold elevation value.
- getElevation(double) - Method in class fr.cnes.sirius.patrius.events.detectors.GroundMaskElevationDetector
-
Get the interpolated elevation for a given azimuth according to the mask.
- getElevation(double) - Method in class fr.cnes.sirius.patrius.fieldsofview.AzimuthElevationField
-
- getElevation(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the elevation of a point with regards to the local point.
- getElevation(Vector3D) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AzimuthElevationCalculator
-
Compute the Elevation of a point defined by its Cartesian coordinates in a
Frame whose x, y and "Reference Azimuth" axis are in the same Plane
- getElevation() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPosition
-
Get the elevation angle.
- getElevation() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPV
-
Get the elevation angle.
- getElevationRate(PVCoordinates, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the elevation rate of a point.
- getElevationRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPV
-
Get the elevation rate.
- getElitismRate() - Method in class fr.cnes.sirius.patrius.math.genetics.ElitisticListPopulation
-
Access the elitism rate.
- getEllipsoid() - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
- getEllipsoid() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
- getEllipsoid(BodyShapeFitter.EllipsoidType) - Method in class fr.cnes.sirius.patrius.bodies.mesh.BodyShapeFitter
-
Getter for the ellipsoid of the desired type.
- getEllipsoidicCoordinates(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Convert from Cartesian to Ellipsoid coordinates
- getEllipticity(double, double) - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
-
Gets the factor of ellipticity using a spline interpolation.
- getEllipticityCorrectionLoveNumber2() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.ITerrestrialTidesDataProvider
-
Get second degree Love number for the ellipticity perturbation.
- getEllipticityCorrectionLoveNumber2() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.TerrestrialTidesDataProvider
-
Get second degree Love number for the ellipticity perturbation.
- getEllipticityFactor() - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
-
- getEm() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getEMB() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the unique Earth-Moon barycenter frame.
- getEME2000() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
Get an EME2000, celestial point centered frame.
- getEME2000() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialPoint
-
Get an EME2000, celestial point centered frame.
- getEME2000() - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Get an EME2000, celestial point centered frame.
- getEME2000() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the unique EME2000 frame.
- getEmissionDate() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the emission date.
- getEmissivity(AbsoluteDate, double, double) - Method in interface fr.cnes.sirius.patrius.forces.radiation.IEmissivityModel
-
Get the albedo and infrared emissivities.
- getEmissivity(AbsoluteDate, double, double) - Method in class fr.cnes.sirius.patrius.forces.radiation.KnockeRiesModel
-
Computing of the emissivities of earth (albedo and infrared) based of the Knocke-Reis model (the longitude is not
used in this model)
See Obelix Reference manuel (NT-07-1)
- getEmitter(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Getter for the signal emitter.
- getEmitter(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Getter for the signal emitter.
- getEmitter(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Getter for the signal emitter.
- getEmitterDatesList() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Getter for the list of the emitter dates of the occurred events.
- getEmitterDatesMap() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Getter for the Map of the emitter (keys) & receiver (values) dates of the occurred events.
- getEmitterPV() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getEmpiricalDistribution() - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
- getEncompassingSphereRadius() - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Getter for the radius, in meters, of a sphere centered on the body frame origin and encompassing the shape.
- getEncompassingSphereRadius() - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Getter for the radius, in meters, of a sphere centered on the body frame origin and encompassing the shape.
- getEncompassingSphereRadius() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the radius, in meters, of a sphere centered on the body frame origin and encompassing the shape.
- getEncompassingSphereRadius() - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
Getter for the radius, in meters, of a sphere centered on the body frame origin and encompassing the shape.
- getEnd() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the Chebyshev polynomial range end date.
- getEnd() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialChebyshevFunction
-
Getter for the end range.
- getEnd() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.LineSegment
-
- getEnd() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Segment
-
Get the end point of the segment.
- getEnd() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Segment
-
Get the end point of the segment.
- getEnd() - Method in interface fr.cnes.sirius.patrius.utils.legs.Leg
-
Returns the leg end date.
- getEndAsDouble() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the end range of the underlying polynomial Chebyshev function.
- getEndDate() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Return the maneuver stop date (if a date or a
DateDetector as been provided).
- getEndDate() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Return the maneuver stop date (if a date or a
DateDetector as been provided).
- getEndDate() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Get the date of the last available Earth Orientation Parameters.
- getEndDate() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
-
- getEndDate() - Method in interface fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistory
-
Get the date of the last available Earth Orientation Parameters.
- getEndDate() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NoEOP2000History
-
getEndDate.
- getEndDate() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Get end date.
- getEndingEvent() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Phenomenon
-
Get the ending event.
- getEndingIsDefined() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Phenomenon
-
True if the second boundary value is defined.
- getEngine(String) - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Public method to search the engine object corresponding to the specified name.
- getEngineCount() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
- getEnginesList() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Returns the engines list.
- getEntireAPMap() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.Stela3StepsSolarActivity
-
Get Geomagnetic activity (AP map).
- getEntireAPMap() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivity
-
Get Geomagnetic activity (AP map).
- getEntireAPMap() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableDispersedSolarActivity
-
Get Geomagnetic activity (AP map).
- getEntireAPMap() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Get Geomagnetic activity (AP map).
- getEntries() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the total number of entries cached.
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Matrix3D
-
Returns the value of one entry of the matrix
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the entry at the specified row and column.
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Gets the entry at the specified row and column.
- getEntry(int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Returns the entry in the specified index.
- getEntry(int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Return the entry at the specified index.
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets the entry at the specified row and column.
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Gets the entry at the specified row and column.
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the entry at the specified row and column.
- getEntry(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the entry at the specified row and column.
- getEntry(int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldVector
-
Returns the entry in the specified index.
- getEntry(int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the entry at the specified row and column.
- getEntry(int) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Return the entry at the specified index.
- getEntry(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.math.parameter.IntervalsFunction
-
- getEntry(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.math.parameter.IntervalsFunction
-
- getEntry(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Getter for the entry associated to the provided date.
- getEntry(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Getter for the entry associated to the provided date.
- getEOP1980History() - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Get Earth Orientation Parameters history (IAU1980) data.
- getEOP1980History(EOPInterpolators) - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Get Earth Orientation Parameters history (IAU1980) data.
- getEOP2000History() - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Get Earth Orientation Parameters history (IAU2000) data.
- getEOP2000History(EOPInterpolators) - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Get Earth Orientation Parameters history (IAU2000) data.
- getEOP2000History(EOPInterpolators, EOP2000HistoryLoader) - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Get Earth Orientation Parameters history (IAU2000) data using a specific loader.
- getEOP2000HistoryConstant() - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Get Earth Orientation Parameters history (IAU2000) data.
- getEOP2000HistoryConstant(EOPInterpolators) - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Get Earth Orientation Parameters history (IAU2000) data.
- getEOP2000HistoryConstant(EOPInterpolators, EOP2000HistoryLoader) - Static method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistoryFactory
-
Get Earth Orientation Parameters history (IAU2000) data using a specific loader.
- getEOPEntryArray() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Getter for the EOP entries array.
- getEOPHistory() - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Get the EOP history.
- getEOPHistory() - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Get the EOP history.
- getEOPInterpolationMethod() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Return the EOP interpolation method.
- getEOPInterpolationMethod() - Method in interface fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistory
-
Return the EOP interpolation method.
- getEOPInterpolationMethod() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NoEOP2000History
-
EOPInterpolators.
- getEOPInterpolationMethod() - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Return the EOP interpolation method.
- getEOPInterpolationMethod() - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Return the EOP interpolation method.
- getEp() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getEphemeris() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
Get the ephemeris of the celestial point.
- getEphemeris() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialPoint
-
Get the ephemeris of the celestial point.
- getEphemeris() - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Get the ephemeris of the celestial point.
- getEphemeris() - Method in class fr.cnes.sirius.patrius.propagation.analytical.AnalyticalEphemerisModeHandler
-
Get the generated ephemeris.
- getEphemeris(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiEphemerisModeHandler
-
Get the generated ephemeris of the given spacecraft Id.
- getEphemerisCacheReusabilityRatio() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Getter for the cache reusability ratio.
- getEphemerisLoader() - Method in class fr.cnes.sirius.patrius.bodies.AbstractJPLCelestialBodyLoader
-
Returns the ephemeris loader.
- getEphemerisMaxSize() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Getter for the maximal internal reference values size before
reinitialization.
- getEphemerisSize() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Getter for the ephemeris size.
- getEphemerisType(String) - Static method in enum fr.cnes.sirius.patrius.bodies.PredefinedEphemerisType
-
Get ephemeris type from JPL/PATRIUS name.
- getEphemerisType() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the type of ephemeris.
- getEpoch() - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
Returns the start epoch of the orbit file.
- getEpoch() - Method in class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
Returns the epoch for this coordinate.
- getEpoch() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the start epoch of the orbit file.
- getEpoch() - Method in class fr.cnes.sirius.patrius.frames.transformations.HelmertTransformation
-
Get the reference epoch of the transform.
- getEpoch() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Getter for the epoch for this magnetic field model.
- getEpoch() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Returns the epoch attribute.
- getEpochDate() - Method in enum fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSType
-
- getEpochInterval() - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
Returns the time interval between epochs (in seconds).
- getEpochInterval() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the time interval between epochs (in seconds).
- getEps() - Method in class fr.cnes.sirius.patrius.math.stat.clustering.DBSCANClusterer
-
Returns the maximum radius of the neighborhood to be considered.
- getEpsilon() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroProperty
-
Getter for the specular reemission percentage.
- getEpsilonSignalPropagation() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
Getter for the epsilon for signal propagation used in
#getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, PropagationDelayType)
method.
- getEpsilonSignalPropagation() - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Getter for the epsilon for signal propagation used in
#getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, PropagationDelayType)
method.
- getEpsilonSignalPropagation() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Getter for the epsilon for signal propagation when signal propagation is taken into account.
- getEpsilonSignalPropagation() - Method in class fr.cnes.sirius.patrius.forces.radiation.LightingRatio
-
Getter for the epsilon for signal propagation when signal propagation is taken into account.
- getEpsilonSignalPropagation() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Getter for the epsilon for signal propagation when signal propagation is taken into account.
- getEquationOfEquinoxes(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.frames.transformations.TODProvider
-
Get the Equation of the Equinoxes at the current date.
- getEquations() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquationsAndTolerances
-
Get the additional equations.
- getEquationsDimension() - Method in interface fr.cnes.sirius.patrius.stela.propagation.StelaAdditionalEquations
-
- getEquationsDimension() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaPartialDerivativesEquations
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Getter for underlying equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into equatorial parameters.
- getEquatorialRadius() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
- getEquatorialRadius() - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
Getter for the equatorial radius of the body.
- getEquatorialRadius() - Method in class fr.cnes.sirius.patrius.bodies.ThreeAxisEllipsoid
-
- getEquatorialRadius() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Spheroid
-
Get equatorial radius of Spheroid.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the first component of the eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the first component of the equinoctial eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the first component of the equinoctial eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the first component of the equinoctial eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the first component of the equinoctial eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the first component of the eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the first component of the equinoctial eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the first component of the equinoctial eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Get the first component of the eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Get the first component of the eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Get the first component of the eccentricity vector.
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the first component of the eccentricity vector (as per equinoctial parameters).
- getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the first component of the eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the second component of the eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the second component of the equinoctial eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the second component of the equinoctial eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the second component of the equinoctial eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the second component of the equinoctial eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the second component of the eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the second component of the equinoctial eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the second component of the equinoctial eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Get the second component of the eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Get the second component of the eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Get the second component of the eccentricity vector.
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the second component of the eccentricity vector (as per equinoctial parameters).
- getEquinoctialEy() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the second component of the eccentricity vector.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Getter for underlying equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into equinoctial parameters.
- getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Getter for underlying equinoctial parameters.
- getEquivalentTransversalSurf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
Get equivalent transversal surface.
- getEquivalentTransversalSurf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularSurfaceCylinder
-
Get equivalent transversal surface.
- getERA(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.stela.bodies.EarthRotation
-
Compute the Earth Rotation Angle (ERA) using Capitaine model (2000).
- getERADerivative(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.stela.bodies.EarthRotation
-
Compute the Earth Rotation Angle (ERA) derivative.
- getErgolsMass() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Returns the sum of ergols masses.
- getErrorCovariance() - Method in class fr.cnes.sirius.patrius.math.filter.KalmanFilter
-
Returns the current error covariance matrix.
- getErrorCovarianceMatrix() - Method in class fr.cnes.sirius.patrius.math.filter.KalmanFilter
-
Returns a copy of the current error covariance matrix.
- getErrorSumSquares() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
- getESplit() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant e split in two pieces.
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the number of function evaluations of the last run of the integrator.
- getEvaluations() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.bivariate.BivariateIntegrator
-
Returns the number of function evaluations made during the last run of
the integrator.
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Returns the number of function evaluations made during the last run of
the integrator.
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevIntegrator
-
Return the current number of function evaluations.
- getEvaluations() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.UnivariateIntegrator
-
Get the number of function evaluations of the last run of the integrator.
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BaseUnivariateSolver
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.dfp.BracketingNthOrderBrentSolverDFP
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Get the number of evaluations of the differential equations function.
- getEvaluations() - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Get the number of evaluations of the differential equations function.
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.optim.BaseMultiStartMultivariateOptimizer
-
Gets the number of evaluations of the objective function.
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.optim.BaseOptimizer
-
Gets the number of evaluations of the objective function.
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.BracketFinder
-
- getEvaluations() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.MultiStartUnivariateOptimizer
-
Gets the number of evaluations of the objective function.
- getEvent() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get event to detect.
- getEventDatationType() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Specify if the event datation type corresponds to the emitter date or the receiver date.
- getEventDatationType() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Specify if the event datation type corresponds to the emitter date or the receiver date.
- getEventDatationType() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Specify if the event datation type corresponds to the emitter date or the receiver date.
- getEventDate(AbstractSignalPropagationDetector.EventDatationType) - Method in class fr.cnes.sirius.patrius.events.postprocessing.EventsLogger.LoggedEvent
-
Returns the event date matching the datation choice and the provided event date.
- getEventDetector() - Method in class fr.cnes.sirius.patrius.events.postprocessing.EventsLogger.LoggedEvent
-
Get the event detector triggered.
- getEventDetector() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiEventsLogger.MultiLoggedEvent
-
Get the event detector triggered.
- getEventDetector() - Method in class fr.cnes.sirius.patrius.events.utils.EventState
-
Get the underlying event detector.
- getEventHandler() - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Get the underlying event handler.
- getEventHandlers() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Get all the event handlers that have been added to the integrator.
- getEventHandlers() - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Get all the event handlers that have been added to the integrator.
- getEvents(String, String, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsList
-
Finds one/more events in the list of
CodedEvent following some criteria.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.drag.DragForce
-
There are no discrete events for this model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in interface fr.cnes.sirius.patrius.forces.ForceModel
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.AbstractTides
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.relativistic.CoriolisRelativisticEffect
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.relativistic.LenseThirringRelativisticEffect
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.relativistic.SchwarzschildRelativisticEffect
-
Get the discrete events related to the model.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Get all the events detectors that have been added.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get all the events
detectors that have been added.
- getEventsDetectors() - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Get all the events
detectors that have been added.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get all the events
detectors that have been added.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get all the events detectors that have been added.
- getEventsDetectors() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Get all the events detectors that have been added.
- getEventsDetectors() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get all the events detectors that have been added.
- getEventTime() - Method in class fr.cnes.sirius.patrius.events.utils.EventState
-
Get the occurrence time of the event triggered in the current step.
- getEventTime() - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Get the occurrence time of the event triggered in the current step.
- getEventType() - Method in interface fr.cnes.sirius.patrius.events.postprocessing.CodingEventDetector
-
Gets a code indicating the type of event we want to log: DELAY when a delay
is associated to the logged events with respect to the detected events, N_OCCURRENCE
when we want to log the nth occurrence of the detected events, STANDARD when no delays
and no occurrence numbers are taken into consideration.
- getEventType() - Method in class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
Gets a code indicating the type of event we want to log: DELAY when a delay
is associated to the logged events with respect to the detected events, N_OCCURRENCE
when we want to log the nth occurrence of the detected events, STANDARD when no delays
and no occurrence numbers are taken into consideration.
- getEventType() - Method in interface fr.cnes.sirius.patrius.events.postprocessing.MultiCodingEventDetector
-
Gets a code indicating the type of event we want to log: DELAY when a delay
is associated to the logged events with respect to the detected events, N_OCCURRENCE
when we want to log the nth occurrence of the detected events, STANDARD when no delays
and no occurrence numbers are taken into consideration.
- getEventType() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiGenericCodingEventDetector
-
Gets a code indicating the type of event we want to log: DELAY when a delay
is associated to the logged events with respect to the detected events, N_OCCURRENCE
when we want to log the nth occurrence of the detected events, STANDARD when no delays
and no occurrence numbers are taken into consideration.
- getException() - Method in exception fr.cnes.sirius.patrius.utils.exception.PatriusExceptionWrapper
-
Get the wrapped exception.
- getExModel() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Get the x eccentricity component parameter model.
- getExosphericTemp() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.JB2006
-
Get the exospheric temperature above input position.
- getExosphericTemperature() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the exospheric temperature.
- getExpectedColumnDimension() - Method in exception fr.cnes.sirius.patrius.math.linear.MatrixDimensionMismatchException
-
- getExpectedDimension(int) - Method in exception fr.cnes.sirius.patrius.math.exception.MultiDimensionMismatchException
-
- getExpectedDimensions() - Method in exception fr.cnes.sirius.patrius.math.exception.MultiDimensionMismatchException
-
- getExpectedRowDimension() - Method in exception fr.cnes.sirius.patrius.math.linear.MatrixDimensionMismatchException
-
- getExpense() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the expense.
- getExponent() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Return the exponent of the instance value, removing the bias.
- getExponent() - Method in class fr.cnes.sirius.patrius.math.distribution.ZipfDistribution
-
Get the exponent characterizing the distribution.
- getExponent(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Return the exponent of a float number, removing the bias.
- getExponent(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Return the exponent of a float number, removing the bias.
- getExponent(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Return the exponent of a float number, removing the bias.
- getExponent(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Return the exponent of a float number, removing the bias.
- getExponent(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Return the exponent of a float number, removing the bias.
- getExponent(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Return the exponent of a float number, removing the bias.
- getExponent(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Return the exponent of a float number, removing the bias.
- getExponent(double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Return the exponent of a float number, removing the bias.
- getExponent(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Return the exponent of a float number, removing the bias.
- getEyModel() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Get the y eccentricity component parameter model.
- getF() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get L - Ω where L is the mean longitude of the Moon.
- getF() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Getter for the flattening.
- getF0(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Objective function value at X.
- getF0() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the objective function to minimize
- getF0() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Objective function.
- getF0(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Objective function value at X.
- getF10(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
Get the value of the instantaneous solar flux index
(1e-22*Watt/(m2*Hertz)).
- getF107() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for f107.
- getF107A() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for f107A.
- getF107Coef() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.Stela3StepsSolarActivity
-
Getter for the F10.7 dispersion coefficient.
- getF10B(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
Get the value of the mean solar flux.
- getFaces() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
- getFacet() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
-
Get the facet.
- getFacet() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeFacetProperty
-
Get the facet.
- getFacets() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.PolyhedronsSet.BRep
-
Get the extracted facets.
- getFactoryKey() - Method in class fr.cnes.sirius.patrius.frames.PredefinedFrame
-
Get the key of the frame within the factory.
- getFc() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for fc.
- getFHi() - Method in exception fr.cnes.sirius.patrius.math.exception.NoBracketingException
-
Get the value at the higher end of the interval.
- getFHi() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.BracketFinder
-
- getFi(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.BarrierMethod
-
Use the barrier function instead.
- getFi(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Inequality functions values at X.
- getFi() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the inequalities constraints array
- getFi() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Inequality functions.
- getFi(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Inequality functions values at X.
- getField() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Get the
Field to which the instance belongs.
- getField() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Get the
Field to which the instance belongs.
- getField() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
- getField() - Method in interface fr.cnes.sirius.patrius.math.FieldElement
-
Get the
Field to which the instance belongs.
- getField() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Get the
Field to which the instance belongs.
- getField() - Method in class fr.cnes.sirius.patrius.math.fraction.Fraction
-
Get the
Field to which the instance belongs.
- getField() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Get the type of field elements of the matrix.
- getField() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Get the type of field elements of the vector.
- getField() - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Get the type of field elements of the matrix.
- getField() - Method in interface fr.cnes.sirius.patrius.math.linear.FieldVector
-
Get the type of field elements of the vector.
- getField() - Method in class fr.cnes.sirius.patrius.math.util.BigReal
-
Get the
Field to which the instance belongs.
- getField() - Method in class fr.cnes.sirius.patrius.math.util.Decimal64
-
Get the
Field to which the instance belongs.
- getField(GeoMagneticFieldFactory.FieldModel, AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticFieldFactory
-
- getField(GeoMagneticFieldFactory.FieldModel, double) - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticFieldFactory
-
- getFieldClass() - Method in class fr.cnes.sirius.patrius.math.parameter.FieldDescriptor
-
Gets the class of the described fields.
- getFieldData(SpacecraftState, IFieldOfView, Vector3D) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the field data as
FieldData for each state in provided list.
- getFieldValue(FieldDescriptor<T>) - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Gets the value currently mapped to a given field descriptor.
- getFieldVector() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticElements
-
Returns the magnetic field vector in the topocentric frame (North=X, East=Y, Nadir=Z) in nTesla.
- getFile(int) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandleManager
-
Return the File object associated with a handle.
- getFile() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceKernelInfo
-
Getter for the file name.
- getFile() - Method in class fr.cnes.sirius.patrius.data.PATRIUSFileInputStream
-
Returns the file associated to the stream.
- getFileDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
Get the date of the file from which data at the specified date comes from.
- getFilename(int) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandleManager
-
Indicate the file name associated to a handle.
- getFilter(int) - Static method in enum fr.cnes.sirius.patrius.utils.AngularDerivativesFilter
-
Get the filter corresponding to a maximum derivation order.
- getFilter(int) - Static method in enum fr.cnes.sirius.patrius.utils.CartesianDerivativesFilter
-
Get the filter corresponding to a maximum derivation order.
- getFinalTime() - Method in class fr.cnes.sirius.patrius.math.ode.ContinuousOutputModel
-
Get the final integration time.
- getFirst() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Returns first EOP entry.
- getFirst() - Method in class fr.cnes.sirius.patrius.math.genetics.ChromosomePair
-
Access the first chromosome.
- getFirst() - Method in class fr.cnes.sirius.patrius.math.util.Pair
-
Getter for the first element of the pair.
- getFirst() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLESeries
-
Get the first TLE.
- getFirstAxis() - Method in class fr.cnes.sirius.patrius.attitudes.TwoDirectionAttitudeLaw
-
Getter for the satellite axis aligned with the first direction.
- getFirstBody() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaThreeBodiesAngleDetector
-
Get 1st body
- getFirstBody() - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
Get 1st body.
- getFirstCommonPseudoInertialAncestor(Frame) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Returns the first pseudo-inertial common ancestor between this and provided frame.
- getFirstCovarianceMatrix() - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
- getFirstDate() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLESeries
-
Get the start date of the series.
- getFirstDate() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the first date.
- getFirstIndex() - Method in class fr.cnes.sirius.patrius.math.ode.EquationsMapper
-
Get the index of the first equation element in complete state arrays.
- getFirstInterval() - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Getter for the first interval.
- getFirstKnownLeapSecond() - Method in class fr.cnes.sirius.patrius.time.UTCScale
-
Get the date of the first known leap second.
- getFirstOccurrence() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get the first occurrence to detect.
- getFirstOptimalDate() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the first optimal date.
- getFirstOrderDimension() - Method in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
-
Returns the number of first order additional states.
- getFirstOrderDimension() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Returns the number of first order additional states.
- getFirstOrderDimension() - Method in interface fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquations
-
Returns the number of first order additional states.
- getFirstPseudoInertialAncestor() - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Returns the first pseudo-inertial ancestor in the frame tree.
- getFirstSample() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the first sample.
- getFirstTimeStampedPVCoordinates() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Getter for the first time-stamped PVCoordinates.
- getFirstUsableDate() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the first usable date.
- getFitness() - Method in class fr.cnes.sirius.patrius.math.genetics.Chromosome
-
Access the fitness of this chromosome.
- getFittedParameters() - Method in class fr.cnes.sirius.patrius.math.fitting.SecularAndHarmonic
-
Get a copy of the last fitted parameters.
- getFittestChromosome() - Method in class fr.cnes.sirius.patrius.math.genetics.ListPopulation
-
Access the fittest chromosome in this population.
- getFittestChromosome() - Method in interface fr.cnes.sirius.patrius.math.genetics.Population
-
Access the fittest chromosome in this population.
- getFixedDateType() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the fixed date : emission or reception.
- getFlagAlbedo() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
-
albedo getter
- getFlagAlbedo() - Method in interface fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationSensitive
-
albedo getter
- getFlagIr() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
-
infrared getter
- getFlagIr() - Method in interface fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationSensitive
-
infrared getter
- getFlattening() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
- getFlattening() - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
Getter for the flattening.
- getFlattening() - Method in class fr.cnes.sirius.patrius.bodies.ThreeAxisEllipsoid
-
- getFLo() - Method in exception fr.cnes.sirius.patrius.math.exception.NoBracketingException
-
Get the value at the lower end of the interval.
- getFLo() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.BracketFinder
-
- getFloorIndex(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the floor index for the given date.
- getFloorSample(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the floor sample for the given date.
- getFlowRate(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the flow rate.
- getFlux() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedFlux
-
Getter for all elementary rediffused fluxes.
- getFlux(Transform) - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedFlux
-
Getter for all elementary rediffused fluxes.
- getFlux(Orbit, PVCoordinates) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Get the solar flux vector.
- getFluxCoef() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableDispersedSolarActivity
-
Get the F10.7 coefficient of the variable solar activity.
- getFluxMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get maximum date of flux values
- getFluxMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get maximum date of flux values
- getFluxMaxDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get maximum date of flux values
- getFluxMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get maximum date of flux values
- getFluxMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get minimum date of flux values
- getFluxMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get minimum date of flux values
- getFluxMinDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get minimum date of flux values
- getFluxMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get minimum date of flux values
- getFMid() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.BracketFinder
-
- getForce() - Method in class fr.cnes.sirius.patrius.wrenches.Wrench
-
- getForceModels() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Returns the propagator force models.
- getForceModels(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get force models list.
- getForceModels() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiPartialDerivativesEquations
-
Returns the propagator force models.
- getForceModels() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get force models list.
- getForceModels() - Method in class fr.cnes.sirius.patrius.propagation.numerical.PartialDerivativesEquations
-
Returns the propagator force models.
- getForceModels() - Method in class fr.cnes.sirius.patrius.stela.orbits.OrbitNatureConverter
-
Returns the force model taken into account in the converter.
- getForceModels() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Get perturbing force models list.
- getForceModelsList() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
Returns a list of all added force models.
- getForcesStepHandler() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Getter for forces step handler.
- getFormat() - Method in class fr.cnes.sirius.patrius.math.geometry.VectorFormat
-
Get the components format.
- getFormat() - Method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Get the components format.
- getFormat() - Method in class fr.cnes.sirius.patrius.math.linear.RealVectorFormat
-
Get the components format.
- getForward() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.FileRecordDAF
-
Getter for the first summary record.
- getFound(int) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandleManager
-
Indicate if the handle is found in the list.
- getFourier() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeriesApproximation
-
- getFOV() - Method in class fr.cnes.sirius.patrius.events.detectors.EarthZoneDetector
-
Getter for FOV list.
- getFOV() - Method in class fr.cnes.sirius.patrius.groundstation.GeometricStationAntenna
-
- getFractionSeconds() - Method in class fr.cnes.sirius.patrius.time.TimeComponents
-
Get the fractional part of seconds.
- getFrame() - Method in interface fr.cnes.sirius.patrius.assembly.IPart
-
- getFrame() - Method in class fr.cnes.sirius.patrius.assembly.MainPart
- getFrame() - Method in class fr.cnes.sirius.patrius.assembly.MobilePart
- getFrame() - Method in class fr.cnes.sirius.patrius.assembly.Part
- getFrame() - Method in class fr.cnes.sirius.patrius.attitudes.directions.ConstantVectorDirection
-
- getFrame() - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Gets the frame of the covariance.
- getFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.EarthZoneDetector
-
Getter for the frame.
- getFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.LocalTimeAngleDetector
-
Returns the frame used for solar time computation.
- getFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.PlaneCrossingDetector
-
Getter for the frame for plane definition.
- getFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Returns the frame used for solar time computation.
- getFrame() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the frame of the acceleration inDirection.
- getFrame() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get the frame of the velocity increment.
- getFrame(PredefinedFrameType) - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get one of the predefined frames.
- getFrame() - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
-
Returns ground station topocentric frame.
- getFrame() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the frame in which the orbital parameters are defined.
- getFrame() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractBoundedPVProvider
-
Getter for the reference frame.
- getFrame() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Get the frame in which the orbit is propagated.
- getFrame(String) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get the frame in which the orbit is propagated.
- getFrame() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
Get the frame in which the orbit is propagated.
- getFrame() - Method in class fr.cnes.sirius.patrius.propagation.AnalyticalIntegratedEphemeris
-
Get the frame in which the orbit is propagated.
- getFrame(String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Get the frame in which the orbit is propagated.
- getFrame() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Returns the propagator frame.
- getFrame(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the frame in which the orbit is propagated.
- getFrame() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiPartialDerivativesEquations
-
Returns the propagator frame.
- getFrame() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get the frame in which the orbit is propagated.
- getFrame() - Method in class fr.cnes.sirius.patrius.propagation.numerical.PartialDerivativesEquations
-
Returns the propagator frame.
- getFrame() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Getter for the frame in which the time-stamped PVCoordinates are defined.
- getFrame() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Get the frame in which the orbit is propagated.
- getFrame() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the inertial frame.
- getFrame() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the reference frame.
- getFrame() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get the frame in which the orbit is propagated.
- getFrameFromClass(int, int, int[], String[], int[]) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceFrame
-
Getter for the frame name, frame ID, and center associated with a given frame class and class ID.
- getFrameOrientation() - Method in class fr.cnes.sirius.patrius.fieldsofview.AzimuthElevationField
-
Returns the frame orientation.
- getFrameOrigin() - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the frame origin point.
- getFree() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.FileRecordDAF
-
Getter for the first free address in the file.
- getFreeParameters() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Get the number of free parameters.
- getFreeParameters() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Get the number of free parameters.
- getFrequency() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
-
- getFrequencyCorrection() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.ITerrestrialTidesDataProvider
-
Get the frequency corrections as a table of Love number corrections associated to a Doodson number i.e. a wave.
- getFrequencyCorrection() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.TerrestrialTidesDataProvider
-
Get the frequency corrections as a table of Love number corrections associated to a Doodson number i.e. a wave.
- getFrobeniusNorm() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
- getFrobeniusNorm() - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
- getFrobeniusNorm() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
- getFrobeniusNorm() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
- getFrozenFrame(Frame, AbsoluteDate, String) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get a new version of the instance, frozen with respect to a reference frame.
- getFrozenFrame(Frame, String) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get a new version of the instance, frozen with respect to a reference frame.
- getFs() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for fs.
- getFunction() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AbstractAeroCoeff1D
-
Getter for the function.
- getFunction() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAoAAndMach
-
Getter for the function.
- getFunction() - Method in class fr.cnes.sirius.patrius.bodies.IAUPoleFunction
-
Returns the IAU pole function.
- getFunction() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.bivariate.BivariateIntegrator
-
Returns the function used during the last run of the integrator.
- getFunction() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Returns the function used during the last run of the integrator.
- getFunction() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeriesApproximation
-
- getFunction() - Method in class fr.cnes.sirius.patrius.math.optim.linear.LinearOptimizer
-
- getFunctions() - Method in class fr.cnes.sirius.patrius.bodies.IAUPoleCoefficients1D
-
Returns the IAU pole functions.
- getFunctions() - Method in class fr.cnes.sirius.patrius.math.parameter.IntervalsFunction
-
Getter for the functions associated to the
intervals.
- getFunctionType() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.AerodynamicProperties
-
Get the type of the aerodynamic coefficients functions among:
- Coefficients as a function of altitude,
- Coefficients as a function of angle of attack
- Coefficients as a function of Mach number
- Coefficients as a function of Mach number and angle of attack.
- getFunctionValueAccuracy() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Get the function value accuracy of the solver.
- getFunctionValueAccuracy() - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BaseUnivariateSolver
-
Get the function value accuracy of the solver.
- getFunctionValueAccuracy() - Method in class fr.cnes.sirius.patrius.math.dfp.BracketingNthOrderBrentSolverDFP
-
Get the function accuracy.
- getG() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the linear inequalities constraints matrix
- getG() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Get the linear inequalities constraints matrix
- getG2() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
- getG2() - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
Getter for the g2 (g squared with g = 1.0 - f).
- getG2() - Method in class fr.cnes.sirius.patrius.bodies.ThreeAxisEllipsoid
-
- getG50() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the G50 reference frame.
- getGain(double, double) - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
-
Gets the antenna gain using a spline interpolation.
- getGAST(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the Greenwich apparent sidereal time, in radians.
- getGAST(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the Greenwich apparent sidereal time, in radians.
- getGaussForceModels() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Get perturbing Gauss force models list.
- getGCRF() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the unique GCRF frame.
- getGenerateCalls() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the number of calls to the generate method.
- getGeneratedEphemeris() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Get the ephemeris generated during propagation.
- getGeneratedEphemeris(String) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Not authorized method: throws an unchecked exception when called.
- getGeneratedEphemeris(String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Get the ephemeris generated during propagation for a defined spacecraft.
- getGeneratedEphemeris(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the ephemeris generated during propagation for a defined spacecraft.
- getGeneratedEphemeris() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get the ephemeris generated during propagation.
- getGeneratedEphemeris() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Get the ephemeris generated during propagation.
- getGeneratedEphemeris() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get the ephemeris generated during propagation.
- getGenerationsEvolved() - Method in class fr.cnes.sirius.patrius.math.genetics.GeneticAlgorithm
-
Returns the number of generations evolved to reach
StoppingCondition in the last run.
- getGenerator() - Method in class fr.cnes.sirius.patrius.math.random.CorrelatedRandomVectorGenerator
-
Get the underlying normalized components generator.
- getGenerator() - Method in class fr.cnes.sirius.patrius.math.random.UniformlyCorrelatedRandomVectorGenerator
-
Get the underlying normalized components generator.
- getGenerator() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the generator.
- getGeneratorUpperBounds() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Returns a fresh copy of the array of upper bounds of the subintervals of [0,1] used in generating data from the
empirical distribution.
- getGeodeticAltitude(Vector3D) - Method in class fr.cnes.sirius.patrius.stela.bodies.GeodPosition
-
Compute geodetic altitude.
- getGeodeticLatitude(Vector3D) - Method in class fr.cnes.sirius.patrius.stela.bodies.GeodPosition
-
Compute geodetic latitude.
- getGeodeticLongitude(Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.bodies.GeodPosition
-
Compute the geodetic longitude at a given date.
- getGeodPosition() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoef
-
Get the geodetic model
- getGeoMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured geometric mean implementation
- getGeoMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the currently configured geometric mean implementation
- getGeoMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured geometric mean implementation
- getGeoMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured geometric mean implementation
- getGeometricMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns the geometric mean of all the aggregated data.
- getGeometricMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
- getGeometricMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
- getGeometricMean() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
geometric mean of the ith entries of the arrays
that correspond to each multivariate sample
- getGeometricMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the geometric mean of the values that have been added.
- getGeometricMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getGeometricMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the geometric mean of the values that have been added.
- getGeometricMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured geometric mean implementation.
- getgLat() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for gLat.
- getGlintPosition(Vector3D, Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GlintApproximatePointingDirection
-
Compute Glint position.
- getGlintVectorPosition(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GlintApproximatePointingDirection
-
Get the position vector of the glint point
- getGlobalCurrentTime() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Get the current global grid point time.
- getGlobalPreviousTime() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Get the previous global grid point time.
- getgLong() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for gLong.
- getGM() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Get the central attraction coefficient of the celestial point.
- getGM() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
Get the central attraction coefficient of the celestial point.
- getGM() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialPoint
-
Get the central attraction coefficient of the celestial point.
- getGM() - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Get the central attraction coefficient of the celestial point.
- getGM() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionData
-
Returns the gravitational constant of the body.
- getGMST(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the Greenwich mean sidereal time, in radians.
- getGMST(AbsoluteDate, FramesConfiguration) - Static method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the Greenwich mean sidereal time, in radians.
- getGMST(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.stela.bodies.EarthRotation
-
Compute Greenwich Mean Sideral Time.
- getGMST() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the Greenwich Mean Sidereal Time scale.
- getGMSTDerivative(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.stela.bodies.EarthRotation
-
Compute Greenwich Mean Sideral Time derivative.
- getGnssType() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getGoalType() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.MultivariateOptimizer
-
- getGoalType() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.UnivariateOptimizer
-
- getGPS() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the Global Positioning System scale.
- getGpsWeek() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the GPS week as contained in the SP3 file.
- getGradF0(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Objective function gradient at X.
- getGradF0(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Objective function gradient at X.
- getGradFi(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.BarrierMethod
-
Use the barrier function instead.
- getGradFi(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Inequality functions gradients values at X.
- getGradFi(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Inequality functions gradients values at X.
- getGravitationalModel(EarthGravitationalModelFactory.GravityFieldNames, String, int, int) - Static method in class fr.cnes.sirius.patrius.forces.gravity.EarthGravitationalModelFactory
-
Create an default instance of a gravitational field of a celestial body using Balmino model and specific data.
- getGravitationalModel(EarthGravitationalModelFactory.GravityFieldNames, String, int, int, boolean) - Static method in class fr.cnes.sirius.patrius.forces.gravity.EarthGravitationalModelFactory
-
Create an default instance of a gravitational field of a celestial body using Balmino model and specific data.
- getGravityModel() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Getter for the gravitational attraction model of the body.
- getGravityModel() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Getter for the gravitational attraction model of the body.
- getGravityModel() - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Getter for the gravitational attraction model of the body.
- getGravityModel() - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
Get the gravitational attraction model.
- getGrid() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionData
-
Returns the grid system.
- getGroundLoss() - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
-
- getGroundPointingLaw() - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointingWrapper
-
Getter for the ground pointing attitude provider without yaw compensation.
- getGST() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the Galileo System Time scale.
- getGTOD(boolean) - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the GTOD reference frame.
- getH() - Method in class fr.cnes.sirius.patrius.math.linear.QRDecomposition
-
Returns the Householder reflector vectors.
- getH() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the linear inequalities constraints coefficients
- getH() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Get the linear inequalities constraints coefficients
- getH0() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
Getter for the Altitude of reference (m).
- getH0() - Method in class fr.cnes.sirius.patrius.frames.H0MinusNFrame
-
Getter for the reference date.
- getH0MinusN(String, AbsoluteDate, double, double) - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the "H0 - n" reference frame.
- getH0MinusN(String, AbsoluteDate, double) - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the "H0 - n" reference frame.
- getHalfAngularAperture() - Method in class fr.cnes.sirius.patrius.fieldsofview.CircularField
-
Returns the half-aperture.
- getHalfAperture() - Method in class fr.cnes.sirius.patrius.events.detectors.CircularFieldOfViewDetector
-
Get fov half aperture angle.
- getHalfAperture1() - Method in class fr.cnes.sirius.patrius.events.detectors.DihedralFieldOfViewDetector
-
Get the half aperture angle of fov 1st dihedra.
- getHalfAperture2() - Method in class fr.cnes.sirius.patrius.events.detectors.DihedralFieldOfViewDetector
-
Get the half aperture angle of fov 2nd dihedra.
- getHandle(String) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandleManager
-
Retrieve handle associated with filename.
- getHandle() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Getter for the state handle.
- getHandle() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceKernelInfo
-
Getter for the handle associated to the file.
- getHandle() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkSegment
-
Getter for the handle associated to the segment.
- getHandleList() - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandle
-
Return a SPICE set containing the handles of all currently open DAFS.
- getHarmonicAmplitude() - Method in class fr.cnes.sirius.patrius.math.fitting.SecularAndHarmonic
-
Get an upper bound of the fitted harmonic amplitude.
- getHeight() - Method in class fr.cnes.sirius.patrius.bodies.LLHCoordinates
-
Getter for the height in meters with respect to the shape surface.
- getHeight() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCone
-
- getHeight() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCylinder
-
- getHeight() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
- getHeight() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RectangleCone
-
- getHeight() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Get z direction dimension (m).
- getHeightFromSurfs(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Get parallelepiped height (Z direction dimension).
- getHeightSystemLabel() - Method in enum fr.cnes.sirius.patrius.bodies.LLHCoordinatesSystem
-
Getter for the label for the managed height coordinate system.
- getHessF0(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Objective function hessian at X.
- getHessF0(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Objective function hessian at X.
- getHessFi(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.BarrierMethod
-
Use the barrier function instead.
- getHessFi(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Inequality functions hessians values at X.
- getHessFi(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Inequality functions hessians values at X.
- getHi() - Method in exception fr.cnes.sirius.patrius.math.exception.NoBracketingException
-
Get the higher end of the interval.
- getHi() - Method in exception fr.cnes.sirius.patrius.math.exception.OutOfRangeException
-
- getHi() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.BracketFinder
-
- getHighestFile() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the highest file number searched during the construction of the segment list.
- getHistory() - Method in class fr.cnes.sirius.patrius.time.UT1Scale
-
Package-private getter for the EOPHistory object.
- getHorizontalIntensity() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticElements
-
Returns the horizontal intensity of the magnetic field (= norm of the
vector in the plane spanned by the x/y components of the field vector).
- getHour() - Method in class fr.cnes.sirius.patrius.time.TimeComponents
-
Get the hour number.
- getHP() - Method in class fr.cnes.sirius.patrius.propagation.numerical.ParameterConfiguration
-
Get parameter step.
- gethPos() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Returns the step used for finite difference computation with respect to spacecraft position.
- getHscale() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
Getter for the Scale factor (m).
- getHumidity() - Method in class fr.cnes.sirius.patrius.signalpropagation.MeteorologicalConditions
-
Getter for the relative humidity [%].
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get hx = ix / (2 * cos(i/2)), where ix is the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get hx = ix / (2 * cos(i/2)), where ix is the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get hx = ix / (2 * cos(i/2)), where ix is the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get hx = ix / (2 * cos(i/2)), where ix is the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get hx = ix / (2 * cos(i/2)), where ix is the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get hx = ix / (2 * cos(i/2)), where ix is the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Get the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Get the first component of the inclination vector.
- getHx() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the first component of the inclination vector (as per equinoctial parameters).
- getHx() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get hx = ix / (2 * cos(i/2)), where ix is the first component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get hy = iy / (2 * cos(i/2)), where iy is the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get hy = iy / (2 * cos(i/2)), where iy is the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get hy = iy / (2 * cos(i/2)), where iy is the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get hy = iy / (2 * cos(i/2)), where iy is the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get hy = iy / (2 * cos(i/2)), where iy is the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get hy = iy / (2 * cos(i/2)), where iy is the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Get the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Get the second component of the inclination vector.
- getHy() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the second component of the inclination vector (as per equinoctial parameters).
- getHy() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get hy = iy / (2 * cos(i/2)), where iy is the second component of the inclination vector.
- getHyperplane() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractSubHyperplane
-
Get the underlying hyperplane.
- getHyperplane() - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.SubHyperplane
-
Get the underlying hyperplane.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getI() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the inclination in [0, π].
- getI() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the inclination.
- getI() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the inclination.
- getIAUPole(PredefinedEphemerisType) - Static method in class fr.cnes.sirius.patrius.bodies.IAUPoleFactory
-
Get an IAU pole.
- getICRF() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
Get an ICRF, celestial point centered frame.
- getICRF() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialPoint
-
Get an ICRF, celestial point centered frame.
- getICRF() - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Get an ICRF, celestial point centered frame.
- getICRF() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the unique ICRF frame.
- getID() - Method in class fr.cnes.sirius.patrius.attitudes.multi.MultiAttitudeProviderWrapper
-
Returns the ID of the spacecraft associated with the AttitudeProvider.
- getId() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkSegment
-
// Check for null input the identifier of the segment.
- getID() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Getter for the triangle identifier.
- getID() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Vertex
-
Returns the vertex identifier.
- getID() - Method in class fr.cnes.sirius.patrius.events.utils.OneSatEventDetectorWrapper
-
Returns the ID of the spacecraft associated with the detector.
- getId() - Method in class fr.cnes.sirius.patrius.tools.parallel.AbstractSimpleParallelTaskImpl
-
- getIdList() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
-
Get the list of spacecraft ID.
- getIdListAddedProviders() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
-
Get the list of added spacecraft providers ID.
- getIEEEFlags() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the IEEE 854 status flags.
- getIERS2003Configuration(boolean) - Static method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationFactory
-
Gets the default IERS2003 configuration (always the same instance, not a new one).
- getIERS2010Configuration() - Static method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationFactory
-
Gets the default IERS2010 configuration (always the same instance, not a new one).
- getIERSConvention() - Method in enum fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationConvention
-
Getter for IERS convention.
- getIGRF(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticFieldFactory
-
Get the IGRF model for the given year.
- getIGRF(double) - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticFieldFactory
-
Get the IGRF model for the given year.
- getImagEigenvalue(int) - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Gets the imaginary part of the ith eigenvalue of the original
matrix.
- getImagEigenvalues() - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Gets a copy of the imaginary parts of the eigenvalues of the original
matrix.
- getImaginary() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Access the imaginary part.
- getImaginary(int) - Method in class fr.cnes.sirius.patrius.math.complex.RootsOfUnity
-
Get the imaginary part of the k-th n-th root of unity.
- getImaginaryCharacter() - Method in class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Access the imaginaryCharacter.
- getImaginaryFormat() - Method in class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Access the imaginaryFormat.
- getImproperInstance() - Static method in class fr.cnes.sirius.patrius.math.fraction.BigFractionFormat
-
Returns the default complex format for the current locale.
- getImproperInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.fraction.BigFractionFormat
-
Returns the default complex format for the given locale.
- getImproperInstance() - Static method in class fr.cnes.sirius.patrius.math.fraction.FractionFormat
-
Returns the default complex format for the current locale.
- getImproperInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.fraction.FractionFormat
-
Returns the default complex format for the given locale.
- getImpulseManeuversList() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
-
Get the continue maneuvers list.
- getInBodyFrame() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Getter for the boby frame used at construction.
- getIncidence() - Method in class fr.cnes.sirius.patrius.events.detectors.NadirSolarIncidenceDetector
-
Getter for the incidence.
- getInclination() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticElements
-
Returns the inclination of the magnetic field in degrees.
- getInclusiveInterval() - Method in class fr.cnes.sirius.patrius.math.interval.ComparableIntervalsList
-
Returns the shortest interval that contains all the intervals of the list.
- getInclusiveInterval() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateIntervalsList
-
Gets the shortest interval containing all the intervals belonging to the list.
- getIncModel() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Get the inclination parameter model.
- getInCorona() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Getter for the number of corona used at construction.
- getIncreasingTimeShift() - Method in class fr.cnes.sirius.patrius.events.utils.EventShifter
-
Get the increasing events time shift.
- getIndex() - Method in exception fr.cnes.sirius.patrius.math.exception.NonMonotonicSequenceException
-
Get the index of the wrong value.
- getIndex() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector.Entry
-
Get the index of the entry.
- getIndex(double) - Method in class fr.cnes.sirius.patrius.math.utils.BinarySearchIndexClosedOpen
-
- getIndex(double, int, int) - Method in class fr.cnes.sirius.patrius.math.utils.BinarySearchIndexClosedOpen
-
- getIndex(double) - Method in class fr.cnes.sirius.patrius.math.utils.BinarySearchIndexOpenClosed
-
- getIndex(double, int, int) - Method in class fr.cnes.sirius.patrius.math.utils.BinarySearchIndexOpenClosed
-
- getIndex(double) - Method in interface fr.cnes.sirius.patrius.math.utils.ISearchIndex
-
Returns the index of x in a tab depending on the convention used.
- getIndex(double, int, int) - Method in interface fr.cnes.sirius.patrius.math.utils.ISearchIndex
-
Returns the index of x in the extracted tab [tab[iMin], tab[iMax]]
depending on the convention used.
- getIndex(double) - Method in class fr.cnes.sirius.patrius.math.utils.RecordSegmentSearchIndex
-
Returns the index of x in a tab depending on the convention used.
- getIndex(double, int, int) - Method in class fr.cnes.sirius.patrius.math.utils.RecordSegmentSearchIndex
-
Returns the index of x in the extracted tab [tab[iMin], tab[iMax]]
depending on the convention used.
- getIndex() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalStateInfo
-
Get the index of the additional state in the state vector.
- getIndex1stOrder() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquationsAndTolerances
-
Returns position of equations in first order state vector.
- getIndex2ndOrder() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquationsAndTolerances
-
Returns position of equations in second order state vector.
- getIndexClosedOpen(double) - Method in class fr.cnes.sirius.patrius.math.utils.RecordSegmentSearchIndex
-
Returns the index of x in a tab depending on the convention used.
- getIndexCurrSummary() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Getter for the index of the current summary within the summary record.
- getIndexInterval(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.AbstractDateIntervalFunction
-
Returns index such as dateIntervals[k] <= date <= dateIntervals[k+1].
- getIndexOpenClosed(double) - Method in class fr.cnes.sirius.patrius.math.utils.RecordSegmentSearchIndex
-
Returns the index of x in a tab depending on the convention used.
- getInEmissivityModel() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Getter for the emissivity model used at construction.
- getInertialDV() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.SmallManeuverAnalyticalModel
-
Get the inertial velocity increment of the maneuver.
- getInertialFrame() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Getter for an inertially oriented, body centered frame.
- getInertialFrame(IAUPoleModelType) - Method in class fr.cnes.sirius.patrius.bodies.AbstractIAUCelestialBody
-
Getter for an inertially oriented, body centered frame.
- getInertialFrame() - Method in class fr.cnes.sirius.patrius.bodies.AbstractIAUCelestialBody
-
Getter for an inertially oriented, body centered frame.
- getInertialFrame() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Getter for an inertially oriented, body centered frame.
- getInertialFrame(IAUPoleModelType) - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Getter for an inertially oriented, body centered frame.
- getInertialFrame(IAUPoleModelType) - Method in interface fr.cnes.sirius.patrius.bodies.IAUCelestialBody
-
Getter for an inertially oriented, body centered frame.
- getInertialFrame() - Method in interface fr.cnes.sirius.patrius.bodies.IAUCelestialBody
-
Getter for an inertially oriented, body centered frame.
- getInertialFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Getter for the inertial frame used for signal propagation computation.
- getInertialFrame() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.SmallManeuverAnalyticalModel
-
Get the inertial frame in which the velocity increment is defined.
- getInertialFrame() - Method in class fr.cnes.sirius.patrius.forces.radiation.LightingRatio
-
Getter for the inertial frame used for signal propagation computation.
- getInertialFrame() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Getter for the inertial frame used for signal propagation computation.
- getInertiaMatrix(Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.assembly.models.IInertiaModel
-
Getter for the inertia matrix of the spacecraft,
expressed with respect to the MASS CENTER in a given frame.
- getInertiaMatrix(Frame, AbsoluteDate, Vector3D) - Method in interface fr.cnes.sirius.patrius.assembly.models.IInertiaModel
-
Getter for the inertia matrix of the spacecraft,
once expressed with respect to a point
that can be different from the mass center.
- getInertiaMatrix(Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
-
Getter for the inertia matrix of the spacecraft,
expressed with respect to the MASS CENTER in a given frame.
- getInertiaMatrix(Frame, AbsoluteDate, Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
-
Getter for the inertia matrix of the spacecraft,
once expressed with respect to a point
that can be different from the mass center.
- getInertiaMatrix(Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
-
Getter for the inertia matrix of the spacecraft,
expressed with respect to the MASS CENTER in a given frame.
- getInertiaMatrix(Frame, AbsoluteDate, Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
-
Getter for the inertia matrix of the spacecraft,
once expressed with respect to a point
that can be different from the mass center.
- getInertiaMatrix() - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
- getInertiaMatrix() - Method in interface fr.cnes.sirius.patrius.assembly.properties.IInertiaProperty
-
- getInertiaMatrix() - Method in class fr.cnes.sirius.patrius.assembly.properties.InertiaCylinderProperty
- getInertiaMatrix() - Method in class fr.cnes.sirius.patrius.assembly.properties.InertiaParallelepipedProperty
- getInertiaMatrix() - Method in class fr.cnes.sirius.patrius.assembly.properties.InertiaSphereProperty
- getInf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Interval
-
Get the lower bound of the interval.
- getInf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.IntervalsSet
-
Get the lowest value belonging to the instance.
- getInformation(boolean, boolean) - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Get information on the space object in a string.
- getInfraRedPressure() - Method in class fr.cnes.sirius.patrius.forces.radiation.ElementaryFlux
-
get the infrared pressure (N/M²)
- getInhibitionFields() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
- getInhibitionFieldsNumber() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getInhibitionNumber() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Get the inhibition number.
- getInhibitionNumber() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Getter for the inhibition number.
- getInhibitionTarget(int) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Returns inhibition field number #i.
- getInhibitionTargetAngularRadius(AbsoluteDate, AbsoluteDate, int, AbstractSignalPropagationDetector.PropagationDelayType) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the angular radius from the sensor of the main target at a date.
- getInhibitionTargets() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
- getInhibitionTargetsRadiuses() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
- getInhibitTargetCenterToFieldAngle(AbsoluteDate, int) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the angular distance of the CENTER of an inhibition target to the border
of the associated inhibition field
at a date.
- getInitialErrorCovariance() - Method in class fr.cnes.sirius.patrius.math.filter.DefaultProcessModel
-
Returns the initial error covariance matrix.
- getInitialErrorCovariance() - Method in interface fr.cnes.sirius.patrius.math.filter.ProcessModel
-
Returns the initial error covariance matrix.
- getInitialGuess() - Method in class fr.cnes.sirius.patrius.math.optim.InitialGuess
-
Gets the initial guess.
- getInitialLagrangian() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get a starting point for the Lagrangian multipliers
- getInitialLagrangian() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the initial Lagrangian
- getInitialPoint() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the feasible starting point for the minimum search
- getInitialPoint() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the initial point
- getInitialState() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Get the propagator initial state.
- getInitialState() - Method in class fr.cnes.sirius.patrius.propagation.analytical.AdapterPropagator
-
Get the propagator initial state.
- getInitialState(String) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get the propagator initial state of a single satellite.
- getInitialState() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get the propagator initial state.
- getInitialState() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.Ephemeris
-
Get the propagator initial state.
- getInitialState() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.IntegratedEphemeris
-
Get the propagator initial state.
- getInitialState() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
-
Get the propagator initial state.
- getInitialState() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Get the propagator initial state.
- getInitialState() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Get the propagator initial state.
- getInitialState() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get the propagator initial state.
- getInitialState() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
-
- getInitialStateEstimate() - Method in class fr.cnes.sirius.patrius.math.filter.DefaultProcessModel
-
Returns the initial state estimation vector.
- getInitialStateEstimate() - Method in interface fr.cnes.sirius.patrius.math.filter.ProcessModel
-
Returns the initial state estimation vector.
- getInitialStates() - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get the propagator initial states.
- getInitialStates() - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Get the propagator initial states.
- getInitialStates() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the propagator initial states.
- getInitialTime() - Method in class fr.cnes.sirius.patrius.math.ode.ContinuousOutputModel
-
Get the initial integration time.
- getInMainSpacecraftId() - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Get the main spacecraft id.
- getInMeridian() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Getter for the number of meridian used at construction.
- getInSecondarySpacecraftId() - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Get the secondary spacecraft id.
- getInSightAxis() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
- getInSpacecraftId1() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaThreeBodiesAngleDetector
-
Get the first spacecraft id
- getInSpacecraftId1() - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
Get the first spacecraft id.
- getInSpacecraftId2() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaThreeBodiesAngleDetector
-
Get the second spacecraft id
- getInSpacecraftId2() - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
Get the second spacecraft id.
- getInSpacecraftId3() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaThreeBodiesAngleDetector
-
Get the third spacecraft id
- getInSpacecraftId3() - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
Get the third spacecraft id.
- getInstance() - Static method in class fr.cnes.sirius.patrius.data.DataProvidersManager
-
Get the unique instance.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.complex.ComplexField
-
Get the unique instance.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Returns the default complex format for the current locale.
- getInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Returns the default complex format for the given locale.
- getInstance(String, Locale) - Static method in class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Returns the default complex format for the given locale.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.fraction.BigFractionField
-
Get the unique instance.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.fraction.FractionField
-
Get the unique instance.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Euclidean1D
-
Get the unique instance.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1DFormat
-
Returns the default 1D vector format for the current locale.
- getInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1DFormat
-
Returns the default 1D vector format for the given locale.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Euclidean3D
-
Get the unique instance.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3DFormat
-
Returns the default 3D vector format for the current locale.
- getInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3DFormat
-
Returns the default 3D vector format for the given locale.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Euclidean2D
-
Get the unique instance.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2DFormat
-
Returns the default 2D vector format for the current locale.
- getInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2DFormat
-
Returns the default 2D vector format for the given locale.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Returns the default real vector format for the current locale.
- getInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Returns the default real vector format for the given locale.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.linear.RealVectorFormat
-
Returns the default real vector format for the current locale.
- getInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.linear.RealVectorFormat
-
Returns the default real vector format for the given locale.
- getInstance(int) - Static method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdamsNordsieckTransformer
-
Get the Nordsieck transformer for a given number of steps.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.ode.sampling.DummyStepHandler
-
Get the only instance.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.util.BigRealField
-
Get the unique instance.
- getInstance() - Static method in class fr.cnes.sirius.patrius.math.util.Decimal64Field
-
Returns the unique instance of this class.
- getInstantFlux(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.DTMInputParameters
-
Get the value of the instantaneous solar flux.
- getInstantFlux(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000InputParameters
-
Get the value of the instantaneous solar flux.
- getInstantFlux(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get the value of the instantaneous solar flux.
- getInstantFlux(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
-
Get the value of the instantaneous solar flux.
- getInstantFlux(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.ContinuousMSISE2000SolarData
-
Get the value of the instantaneous solar flux.
- getInstantFlux(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.DTMSolarData
-
Get the value of the instantaneous solar flux.
- getInstantFlux(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
Get the value of the instantaneous solar flux.
- getInstantFluxValue(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get instant flux values at the given dates (possibly interpolated)
- getInstantFluxValue(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get instant flux values at the given dates (possibly interpolated)
- getInstantFluxValue(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get instant flux values at the given dates (possibly interpolated)
- getInstantFluxValue(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get instant flux values at the given dates (possibly interpolated)
- getInstantFluxValue(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaLOSConstantSolarActivity
-
Get Solar activity flux at a specified date.
- getInstantFluxValue(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.stela.forces.solaractivity.IStelaSolarActivity
-
Get Solar activity flux at a specified date.
- getInstantFluxValue(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableDispersedSolarActivity
-
Get Solar activity flux at a specified date.
- getInstantFluxValue(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Get Solar activity flux at a specified date.
- getInstantFluxValues(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get raw instant flux values between the given dates
- getInstantFluxValues(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get raw instant flux values between the given dates
- getInstantFluxValues(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get raw instant flux values between the given dates
- getInstantFluxValues(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get raw instant flux values between the given dates
- getInSun() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Getter for the coordinate of sun used at construction.
- getIntegrator() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractVector3DFunction
-
Get the integrator.
- getIntegratorX() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Gets the univariate integrator associated to the 1st axis.
- getIntegratorY() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Gets the univariate integrator associated to the 2nd axis.
- getIntercept() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
- getInterceptStdErr() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
- getInteriorPointMethod() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the chosen interior-point method
- getInteriorPointMethod() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the chosen interior point method.
- getInternalFilename() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.FileRecordDAF
-
Getter for the internal file name.
- getInterpolatedDate() - Method in class fr.cnes.sirius.patrius.propagation.sampling.AdaptedStepHandler
-
Get the interpolated date.
- getInterpolatedDate() - Method in class fr.cnes.sirius.patrius.propagation.sampling.BasicStepInterpolator
-
Get the interpolated date.
- getInterpolatedDate() - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
-
Get the interpolated date.
- getInterpolatedDate() - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiPatriusStepInterpolator
-
Get the interpolated date.
- getInterpolatedDate() - Method in interface fr.cnes.sirius.patrius.propagation.sampling.PatriusStepInterpolator
-
Get the interpolated date.
- getInterpolatedDate() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
-
Get the interpolated date.
- getInterpolatedDerivatives() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Get the derivatives of the state vector of the interpolated point.
- getInterpolatedDerivatives() - Method in interface fr.cnes.sirius.patrius.math.ode.sampling.StepInterpolator
-
Get the derivatives of the state vector of the interpolated point.
- getInterpolatedSecondaryDerivatives(int) - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Get the interpolated secondary derivatives corresponding to the secondary equations.
- getInterpolatedSecondaryDerivatives(int) - Method in interface fr.cnes.sirius.patrius.math.ode.sampling.StepInterpolator
-
Get the interpolated secondary derivatives corresponding to the secondary equations.
- getInterpolatedSecondaryState(int) - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Get the interpolated secondary state corresponding to the secondary equations.
- getInterpolatedSecondaryState(int) - Method in interface fr.cnes.sirius.patrius.math.ode.sampling.StepInterpolator
-
Get the interpolated secondary state corresponding to the secondary equations.
- getInterpolatedState() - Method in class fr.cnes.sirius.patrius.math.ode.ContinuousOutputModel
-
Get the state vector of the interpolated point.
- getInterpolatedState() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Get the state vector of the interpolated point.
- getInterpolatedState() - Method in interface fr.cnes.sirius.patrius.math.ode.sampling.StepInterpolator
-
Get the state vector of the interpolated point.
- getInterpolatedState() - Method in class fr.cnes.sirius.patrius.propagation.sampling.AdaptedStepHandler
-
Get the interpolated state.
- getInterpolatedState() - Method in class fr.cnes.sirius.patrius.propagation.sampling.BasicStepInterpolator
-
Get the interpolated state.
- getInterpolatedState() - Method in interface fr.cnes.sirius.patrius.propagation.sampling.PatriusStepInterpolator
-
Get the interpolated state.
- getInterpolatedState() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
-
Get the interpolated state.
- getInterpolatedStates() - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
-
Get all the interpolated states.
- getInterpolatedStates() - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiPatriusStepInterpolator
-
Get all the interpolated states.
- getInterpolatedStateVariation() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.NordsieckStepInterpolator
-
Get the state vector variation from current to interpolated state.
- getInterpolatedTime() - Method in class fr.cnes.sirius.patrius.math.ode.ContinuousOutputModel
-
Get the time of the interpolated point.
- getInterpolatedTime() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Get the time of the interpolated point.
- getInterpolatedTime() - Method in interface fr.cnes.sirius.patrius.math.ode.sampling.StepInterpolator
-
Get the time of the interpolated point.
- getInterpolatingPoints() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the interpolating points array.
- getInterpolatingTabValues() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the interpolating values matrix.
- getInterpolatingValues() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the interpolating values array.
- getInterpolationOrder() - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Getter for the interpolation order.
- getInterpolationOrder() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Getter for the interpolation order.
- getInterpolationPoints() - Method in enum fr.cnes.sirius.patrius.frames.configuration.eop.EOPInterpolators
-
Return the number of points to use in interpolation.
- getInterpolationStep() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Getter for the interpolation step.
- getIntersection(Line, Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the intersection point of a line with the surface of the body.
- getIntersection(Line) - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Getter for the intersection point with triangle, null if there is no intersection or if line is included in
triangle.
- getIntersection(Segment) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Segment
-
Returns the intersection between two segments, null if there is no intersection.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Getter for the intersection point of a line with the surface of the body.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate, String) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Getwter for the intersection point of a line with the surface of the body.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Getter for the intersection point of a line with the surface of the body.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate, String) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Getwter for the intersection point of a line with the surface of the body.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Getter for the intersection point of a line with the surface of the body for a given altitude.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Getter for the intersection point of a line with the surface of the body.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate, String) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Getwter for the intersection point of a line with the surface of the body.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Getter for the intersection point of a line with the surface of the body for a given altitude.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the intersection point of a line with the surface of the body.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate, String) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getwter for the intersection point of a line with the surface of the body.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the intersection point of a line with the surface of the body for a given altitude.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
Getter for the intersection point of a line with the surface of the body for a given altitude.
- getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.bodies.ThreeAxisEllipsoid
-
Getter for the intersection point of a line with the surface of the body for a given altitude.
- getIntersectionPoints(Line, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Compute the intersection points with a line.
- getIntersectionPoints(Line, Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Compute the intersection points with a line.
- getIntersectionPoints(Line, Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
Compute the intersection points with a line.
- getIntersectionPoints(Line, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractEllipse
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
If more than one intersection points are found, the closest to the line's origin is returned first.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCone
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCylinder
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This methods computes and returns the intersection points between a line and the cone.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
This methods computes and returns the intersection points between a line and the cylinder.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCone
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCylinder
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCone
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCylinder
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Compute the intersection points with another line if it exists.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RectangleCone
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCone
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Shape
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Compute the intersection points with a line.
- getIntersectionPoints(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCap
-
Returns a list of intersection points between the line and the spherical cap.
- getIntersectionWith(PyramidalField) - Method in class fr.cnes.sirius.patrius.fieldsofview.PyramidalField
-
Build a new
PyramidalField from the intersection between this field of view and the provided one.
- getIntersectionWith(ComparableInterval<T>) - Method in class fr.cnes.sirius.patrius.math.interval.ComparableInterval
-
Returns the intersection with another interval.
- getIntersectionWith(ComparableInterval<T>) - Method in class fr.cnes.sirius.patrius.math.interval.ComparableIntervalsList
-
Returns the intersection between an interval and all the intervals of the list.
- getIntersectionWith(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Returns the intersection with another interval.
- getIntersectionWith(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateIntervalsList
-
Returns the intersection between an interval and all the intervals of the list.
- getIntervalDataAssociation() - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Getter for the association between
intervals and data.
- getIntervalFunctionAssociation() - Method in class fr.cnes.sirius.patrius.math.parameter.IntervalsFunction
-
Getter for the association between
intervals and functions.
- getIntervalOfValidity() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
-
- getIntervals() - Method in class fr.cnes.sirius.patrius.math.parameter.IntervalsFunction
-
Getter for the available intervals.
- getIntervals() - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Getter for the available intervals.
- getIntervalsContaining(T) - Method in class fr.cnes.sirius.patrius.math.interval.ComparableIntervalsList
-
Returns the intervals of the list that contain the provided entry.
- getIntervalsContainingDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateIntervalsList
-
- getIntVals(String) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.PoolSpice
-
Return the integer value of a kernel variable from the kernel pool.
- getInverse(boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the inverse transform of the instance.
- getInverse() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the inverse transform of the instance.
- getInverse() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Returns the inverse of this instance.
- getInverse() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the default decomposition.
- getInverse(Function<RealMatrix, Decomposition>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the given decomposition algorithm.
- getInverse() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the default decomposition.
- getInverse(Function<RealMatrix, Decomposition>) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the given decomposition algorithm.
- getInverse() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the default decomposition.
- getInverse(Function<RealMatrix, Decomposition>) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the given decomposition algorithm.
- getInverse() - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the inverse of the matrix.
- getInverse(Function<RealMatrix, Decomposition>) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the inverse of the matrix.
- getInverse() - Method in interface fr.cnes.sirius.patrius.math.linear.DecompositionSolver
-
Get the inverse (or pseudo-inverse) of the decomposed matrix.
- getInverse() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the default decomposition.
- getInverse(Function<RealMatrix, Decomposition>) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the given decomposition algorithm.
- getInverse() - Method in interface fr.cnes.sirius.patrius.math.linear.FieldDecompositionSolver
-
Get the inverse (or pseudo-inverse) of the decomposed matrix.
- getInverse() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the default decomposition.
- getInverse(Function<RealMatrix, Decomposition>) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the given decomposition algorithm.
- getInverse() - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the default decomposition.
- getInverse(Function<RealMatrix, Decomposition>) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the given decomposition algorithm.
- getInverse() - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricPositiveMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the default decomposition.
- getInverse(Function<RealMatrix, Decomposition>) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricPositiveMatrix
-
Gets the inverse (or pseudo-inverse) of this matrix using the given decomposition algorithm.
- getInverse() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.CholeskyFactorization
-
Compute the inverse of the matrix.
- getInverseConditionNumber() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Computes the inverse of the condition number.
- getIonoCorrection(TopocentricFrame) - Method in class fr.cnes.sirius.patrius.signalpropagation.ionosphere.AbstractIonosphericCorrectionFactory
-
Getter for an ionospheric correction model.
- getiRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getIsp() - Method in class fr.cnes.sirius.patrius.assembly.properties.PropulsiveProperty
-
- getIsp(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.properties.PropulsiveProperty
-
- getISP(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the specific impulse.
- getISP() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the specific impulse.
- getIsp() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get the specific impulse.
- getIspParam() - Method in class fr.cnes.sirius.patrius.assembly.properties.PropulsiveProperty
-
- getIterationManager() - Method in class fr.cnes.sirius.patrius.math.linear.IterativeLinearSolver
-
Returns the iteration manager attached to this solver.
- getIterations() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the number of iterations of the last run of the integrator.
- getIterations() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.UnivariateIntegrator
-
Get the number of iterations of the last run of the integrator.
- getIterations() - Method in class fr.cnes.sirius.patrius.math.optim.BaseOptimizer
-
Gets the number of iterations performed by the algorithm.
- getIterations() - Method in class fr.cnes.sirius.patrius.math.util.IterationEvent
-
Returns the number of iterations performed at the time this event
is created.
- getIterations() - Method in class fr.cnes.sirius.patrius.math.util.IterationManager
-
Returns the number of iterations of this solver, 0 if no iterations has
been performed yet.
- getITRF() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the ITRF reference frame.
- getITRFEquinox() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the equinox-based ITRF reference frame.
- getIx() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the first component of the inclination vector.
- getIx() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Get the first component of the inclination vector.
- getIx() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Get the first component of the inclination vector.
- getIx() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the first component of the inclination vector.
- getIy() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the second component of the inclination vector.
- getIy() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Get the second component of the inclination vector.
- getIy() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Get the second component of the inclination vector.
- getIy() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the second component of the inclination vector.
- getJ(boolean, int) - Method in interface fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsProvider
-
Get the zonal coefficients.
- getJ(boolean, int) - Method in class fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsReader
-
Get the zonal coefficients.
- getJ2000Day() - Method in class fr.cnes.sirius.patrius.time.DateComponents
-
Get the day number with respect to J2000 epoch.
- getJacobian(Orbit, PositionAngle, double[][]) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.SmallManeuverAnalyticalModel
-
Compute the Jacobian of the orbit with respect to maneuver parameters.
- getJacobian(double[][]) - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
- getJacobian(OrbitType, OrbitType) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get coordinate conversion jacobian.
- getJacobian(OrbitType, OrbitType, PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get coordinate conversion jacobian.
- getJacobian(Frame, Frame, OrbitType, OrbitType, PositionAngle, PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Computes the Jacobian of the transformation between the specified frames, orbit types and
position angle types with respect to this orbit.
- getJacobian(double, Frame, Frame, OrbitType, OrbitType, PositionAngle, PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Computes the Jacobian of the transformation between the specified frames, orbit types and
position angle types with respect to this orbit and specified time shift.
- getJacobianCartesianToSpheric(PVCoordinates) - Static method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.JacobianTransformationMatrix
-
Get Jacobian for spheric coordinates transformation to cartesian
coordinates
- getJacobianParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.AeroModel
-
Get the list of all jacobian parameters supported.
- getJacobianParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
-
Get the list of all jacobian parameters supported.
- getJacobianParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.DragLiftModel
-
Get the list of all jacobian parameters supported.
- getJacobianParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.GlobalAeroModel
-
Get the list of all jacobian parameters supported.
- getJacobianParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
-
Get the list of all jacobian parameters supported.
- getJacobianParameters() - Method in interface fr.cnes.sirius.patrius.propagation.numerical.JacobianParametersProvider
-
Get the list of all jacobian parameters supported.
- getJacobianParameters() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAeroModel
-
Get the list of all jacobian parameters supported.
- getJacobianSphericToCartesian(PVCoordinates) - Static method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.JacobianTransformationMatrix
-
Get Jacobian for cartesian coordinates transformation to spheric
coordinates.
- getJacobiansProviders() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Get the list of jacobians providers.
- getJacobianWrtCartesian(PositionAngle, double[][]) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Compute the Jacobian of the orbital parameters with respect to the Cartesian parameters.
- getJacobianWrtParameters(PositionAngle, double[][]) - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Compute the Jacobian of the Cartesian parameters with respect to the orbital parameters.
- getJacobianWrtParameters(PositionAngle, double[][]) - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Compute the Jacobian of the Cartesian parameters with respect to the orbital parameters.
- getJacobianWrtParameters(PositionAngle, double[][]) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Compute the Jacobian of the Cartesian parameters with respect to the orbital parameters.
- getJacobianWrtParametersEccentric() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- getJacobianWrtParametersMean() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- getJacobianWrtParametersTrue() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- getJulianDay() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the julian day for this SP3 file.
- getJupiter() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Jupiter singleton body.
- getJupiterThirdBodyAttraction() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getK() - Method in class fr.cnes.sirius.patrius.math.util.Combinations
-
Gets the number of elements in each combination.
- getK0Albedo() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
-
K0 albedo getter
- getK0Albedo() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Getter for the albedo global multiplicative factor used at construction.
- getK0Albedo() - Method in interface fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationSensitive
-
K0 albedo getter
- getK0Ir() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
-
K0 infrared getter
- getK0Ir() - Method in class fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationPressure
-
Getter for the infrared global multiplicative factor used at construction.
- getK0Ir() - Method in interface fr.cnes.sirius.patrius.forces.radiation.RediffusedRadiationSensitive
-
K0 infrared getter
- getKeplerianMeanMotion() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the keplerian mean motion.
- getKeplerianMeanMotion() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the keplerian mean motion.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Getter for underlying keplerian parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into circular parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into Keplerian parameters.
- getKeplerianPeriod() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the keplerian period.
- getKeplerianPeriod() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the keplerian period.
- getKeplerianTransitionMatrix(double) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get keplerian transition matrix.
- getKey() - Method in class fr.cnes.sirius.patrius.math.util.Pair
-
Getter for the key.
- getKey() - Method in class fr.cnes.sirius.patrius.tools.cache.CacheEntry
-
Getter for the key of the entry.
- getKeys() - Method in class fr.cnes.sirius.patrius.math.exception.util.ExceptionContext
-
Gets all the keys stored in the exception
- getKnots() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialSplineFunction
-
Get an array copy of the knot points.
- getKp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get Kp value at given user date
- getKp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get Kp value at given user date
- getKp(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get Kp value at given user date
- getKp(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get Kp value at given user date
- getKurtosis() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the Kurtosis of the available values.
- getKurtosisImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured kurtosis implementation.
- getL() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean anomaly of the Moon.
- getL() - Method in class fr.cnes.sirius.patrius.math.linear.CholeskyDecomposition
-
Returns the matrix L of the decomposition.
- getL() - Method in class fr.cnes.sirius.patrius.math.linear.FieldLUDecomposition
-
Returns the matrix L of the decomposition.
- getL() - Method in class fr.cnes.sirius.patrius.math.linear.LUDecomposition
-
Returns the matrix L of the decomposition.
- getL() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.CholeskyFactorization
-
Returns the matrix L of the decomposition.
- getL(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the longitude argument.
- getL(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the longitude argument.
- getL(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Get the longitude argument.
- getL(PositionAngle) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Get the longitude argument.
- getL1Distance(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Distance between two vectors.
- getL1Distance(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Distance between two vectors.
- getL1Norm() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Returns the L1 norm of the vector.
- getL1Norm() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Returns the L1 norm of the vector.
- getLagrangeForceModels() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Get perturbing Lagrange force models list.
- getLargest() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.AVLTree
-
Get the node whose element is the largest one in the tree.
- getLast() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Returns last EOP entry.
- getLast() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLESeries
-
Get the last TLE.
- getLastDate() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLESeries
-
Get the last date of the series.
- getLastDate() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the last date.
- getLastInterval() - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Getter for the last interval.
- getLastKnownLeapSecond() - Method in class fr.cnes.sirius.patrius.time.UTCScale
-
Get the date of the last known leap second.
- getLastNameRecord() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Getter for the name of the last name record read.
- getLastOccurrence() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get the last occurrence to detect.
- getLastOptimalDate() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the last optimal date.
- getLastSample() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the last sample.
- getLastSummaryRecord() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Getter for the contents of the last summary record.
- getLastTimeStampedPVCoordinates() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Getter for the last time-stamped PVCoordinates.
- getLastUsableDate() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the last usable date.
- getLatest() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the latest cached entry.
- getLatitude() - Method in class fr.cnes.sirius.patrius.bodies.LLHCoordinates
-
Getter for the latitude.
- getLatitude() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Getter for the latitude.
- getLatitudeToDetect() - Method in class fr.cnes.sirius.patrius.events.detectors.LatitudeDetector
-
Getter for the latitude to detect.
- getLatLongSystemLabel() - Method in enum fr.cnes.sirius.patrius.bodies.LLHCoordinatesSystem
-
Getter for the label for the managed lat/long coordinates system.
- getLaunchNumber() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the launch number.
- getLaunchPiece() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the launch piece.
- getLaunchYear() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the launch year.
- getLb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the lower bounds
- getLb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Get the lower bounds
- getLb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Return the lower bounds for the problem.
- getLbModel() - Method in class fr.cnes.sirius.patrius.events.detectors.RFVisibilityDetector
-
Get the RF link budget model.
- getLbThreshold() - Method in class fr.cnes.sirius.patrius.events.detectors.RFVisibilityDetector
-
Get the RF link budget threshold.
- getLE() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean Earth longitude.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Get the eccentric longitude argument.
- getLE() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the eccentric longitude argument (as per equinoctial parameters).
- getLE() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the eccentric longitude argument.
- getLeap(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.UTCScale
-
Get the value of the previous leap.
- getLength() - Method in class fr.cnes.sirius.patrius.math.genetics.AbstractListChromosome
-
Returns the length of the chromosome.
- getLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCylinder
-
- getLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.LineSegment
-
- getLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
- getLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RectangleCone
-
- getLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCone
-
- getLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
- getLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularSurfaceCylinder
-
Get length corresponding to transversal surface (x length) (m).
- getLength() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Get x direction dimension (m).
- getLength() - Method in class fr.cnes.sirius.patrius.math.interval.AngleInterval
-
- getLengthFromSurfs(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Get parallelepiped length (X direction dimension).
- getLengthFromTSurfaceAndRadius(double, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularSurfaceCylinder
-
Get length from the transversal surface and radius.
- getLenseThirringRelativisticEffect() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getLibrationCorrectionModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.DiurnalRotation
-
- getLibrationCorrectionModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.PolarMotion
-
- getLiftCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
-
Get the lift coefficient.
- getLiftCoef() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.AerodynamicProperties
-
Get the lift coefficient.
- getLightingRatio(Vector3D, BodyShape, PVCoordinatesProvider, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Get the lighting ratio ([0-1]) for provided occulting body.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.CelestialBodyPolesAxisDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.ConstantVectorDirection
-
Provides the line containing the given origin point and directed by the direction vector
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.CrossProductDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the cross product of directions.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthCenterDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, ITargetDirection.SignalDirection, ITargetDirection.AberrationCorrection, AbsoluteDate, VacuumSignalPropagationModel.FixedDate, Frame, double) - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthCenterDirection
-
Provides the half line containing both origin and target, taking into account the type of date (emission or
reception), corrected for light-time and stellar aberration pending the entered correction parameter.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthToCelestialPointDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, ITargetDirection.SignalDirection, ITargetDirection.AberrationCorrection, AbsoluteDate, VacuumSignalPropagationModel.FixedDate, Frame, double) - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthToCelestialPointDirection
-
Provides the half line containing both origin and target, taking into account the type of date (emission or
reception), corrected for light-time and stellar aberration pending the entered correction parameter.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GenericTargetDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, ITargetDirection.SignalDirection, ITargetDirection.AberrationCorrection, AbsoluteDate, VacuumSignalPropagationModel.FixedDate, Frame, double) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GenericTargetDirection
-
Provides the half line containing both origin and target, taking into account the type of date (emission or
reception), corrected for light-time and stellar aberration pending the entered correction parameter.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GlintApproximatePointingDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GroundVelocityDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.attitudes.directions.IDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, ITargetDirection.SignalDirection, ITargetDirection.AberrationCorrection, AbsoluteDate, VacuumSignalPropagationModel.FixedDate, Frame, double) - Method in interface fr.cnes.sirius.patrius.attitudes.directions.ITargetDirection
-
Provides the half line containing both origin and target, taking into account the type of date (emission or
reception), corrected for light-time and stellar aberration pending the entered correction parameter.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.MomentumDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.NadirDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.NorthNormalToEclipticDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.ToCelestialPointDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, ITargetDirection.SignalDirection, ITargetDirection.AberrationCorrection, AbsoluteDate, VacuumSignalPropagationModel.FixedDate, Frame, double) - Method in class fr.cnes.sirius.patrius.attitudes.directions.ToCelestialPointDirection
-
Provides the half line containing both origin and target, taking into account the type of date (emission or
reception), corrected for light-time and stellar aberration pending the entered correction parameter.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.VelocityDirection
-
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
- getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.bodies.BasicBoardSun
-
Get the line from the position in pvCoord to the Sun.
- getLine() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Segment
-
Get the line containing the segment.
- getLine() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Segment
-
Get the line containing the segment.
- getLine1() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the first line.
- getLine2() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the second line.
- getLinearPolynomial() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialPrimitive
-
Get the Linear Polynomial Part
- getLineProperty() - Method in class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
-
Getter for the line property.
- getLineProperty() - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
-
Getter for the line property.
- getLineProperty() - Method in interface fr.cnes.sirius.patrius.projections.IProjection
-
Getter for the line property.
- getLineProperty() - Method in class fr.cnes.sirius.patrius.projections.Mercator
-
Getter for the line property.
- getLInfDistance(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Distance between two vectors.
- getLInfDistance(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Distance between two vectors.
- getLInfNorm() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Returns the L∞ norm of the vector.
- getLInfNorm() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Returns the L∞ norm of the vector.
- getLinkType() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractStationToSatDetector
-
Returns the type of link (it can be uplink or downlink).
- getLinkType() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaElevationDetector
-
Returns the type of link (it can be uplink or downlink).
- getLinkType() - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Returns the type of link (it can be uplink or downlink).
- getLinkType() - Method in enum fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector.SatToSatLinkType
-
Returns the link type.
- getLinkTypeHandler() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Getter for the link type handler.
- getList() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsList
-
Get the full list of coded events.
- getList() - Method in class fr.cnes.sirius.patrius.events.postprocessing.PhenomenaList
-
- getLJu() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean Jupiter longitude.
- getLLHCoordinates(LLHCoordinatesSystem) - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Returns (after computation if not computed yet) the latitude/longitude/height coordinates of this in the
requested coordinates system.
- getLLHCoordinates() - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Returns (after computation if not computed yet) the latitude/longitude/height coordinates of this in the
associated body shape preferred coordinates system.
- getLLHCoordinates(LLHCoordinatesSystem) - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Returns (after computation if not computed yet) the latitude/longitude/height coordinates of this in the
requested coordinates system.
- getLLHCoordinatesSystem() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
Getter for the LLH coordinates system used by the computed
BodyPoint.
- getLLHCoordinatesSystem() - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Getter for the LLH coordinates system used by the computed
BodyPoint.
- getLLHCoordinatesSystem() - Method in class fr.cnes.sirius.patrius.bodies.LLHCoordinates
-
Getter for the used LLH coordinates system.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Get the mean longitude argument.
- getLM() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the mean longitude argument (as per equinoctial parameters).
- getLM() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the mean longitude argument.
- getLMa() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean Mars longitude.
- getLMe() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean Mercury longitude.
- getLn10() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant ln(10).
- getLn2() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant ln(2).
- getLn2Split() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant ln(2) split in two pieces.
- getLn5() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant ln(5).
- getLn5Split() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant ln(5) split in two pieces.
- getLnaModel() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Get the longitude of ascending node parameter model.
- getLNe() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean Neptune longitude.
- getLo() - Method in exception fr.cnes.sirius.patrius.math.exception.NoBracketingException
-
Get the lower end of the interval.
- getLo() - Method in exception fr.cnes.sirius.patrius.math.exception.OutOfRangeException
-
- getLo() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.BracketFinder
-
- getLoadedAstronomicalUnit() - Method in class fr.cnes.sirius.patrius.bodies.JPLHistoricEphemerisLoader
-
Get astronomical unit.
- getLoadedConstant(String...) - Method in class fr.cnes.sirius.patrius.bodies.JPLHistoricEphemerisLoader
-
Get a constant defined in the ephemerides headers.
- getLoadedDataNames() - Method in class fr.cnes.sirius.patrius.data.DataProvidersManager
-
Get an unmodifiable view of the set of data file names that have been loaded.
- getLoadedEarthMoonMassRatio() - Method in class fr.cnes.sirius.patrius.bodies.JPLHistoricEphemerisLoader
-
Get Earth/Moon mass ratio.
- getLoadedGravitationalCoefficient(PredefinedEphemerisType) - Method in class fr.cnes.sirius.patrius.bodies.AbstractJPLCelestialBodyLoader
-
Get the gravitational coefficient of a body.
- getLoadedGravitationalCoefficient(PredefinedEphemerisType) - Method in class fr.cnes.sirius.patrius.bodies.bsp.BSPEphemerisLoader
-
Get the gravitational coefficient of a body.
- getLoadedGravitationalCoefficient(PredefinedEphemerisType) - Method in interface fr.cnes.sirius.patrius.bodies.JPLEphemerisLoader
-
Get the gravitational coefficient of a body.
- getLoadedGravitationalCoefficient(PredefinedEphemerisType) - Method in class fr.cnes.sirius.patrius.bodies.JPLHistoricEphemerisLoader
-
Get the gravitational coefficient of a body.
- getLoadedPastCyclesSolarActivityReader() - Static method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Get the loaded past cycles solar activity reader
- getLoader(String) - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Gets the loader for the specific name of the celestial body provided in input.
- getLocalBasisTransform() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Get transformation matrix (from standard basis to ellipsoid local basis)
- getLocalBasisTransform() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This method returns the matrix of the transformation to the local basis
- getLocalBasisTransform() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
This method returns the matrix of the transformation to the local basis
- getLocalFrame() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
- getLocalizedMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathArithmeticException
- getLocalizedMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathIllegalArgumentException
- getLocalizedMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathIllegalStateException
- getLocalizedMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathRuntimeException
- getLocalizedMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathUnsupportedOperationException
- getLocalizedMessage() - Method in class fr.cnes.sirius.patrius.math.exception.util.ExceptionContext
-
Gets the message in the default locale.
- getLocalizedMessage() - Method in exception fr.cnes.sirius.patrius.utils.exception.PatriusException
- getLocalizedString(Locale) - Method in class fr.cnes.sirius.patrius.math.exception.util.DummyLocalizable
-
Gets the localized string.
- getLocalizedString(Locale) - Method in interface fr.cnes.sirius.patrius.math.exception.util.Localizable
-
Gets the localized string.
- getLocalizedString(Locale) - Method in enum fr.cnes.sirius.patrius.utils.exception.PatriusMessages
-
Gets the localized string.
- getLocalTemp() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.JB2006
-
Get the temperature at input position.
- getLocalTemperature() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the local temperature.
- getLocation() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.OrientedPoint
-
Get the hyperplane location on the real line.
- getLOD(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Get the LoD (Length of Day) value.
- getLOD(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
-
Get the LoD (Length of Day) value.
- getLOD() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPEntry
-
Get the LoD (Length of Day) value.
- getLOD(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistory
-
Get the LoD (Length of Day) value.
- getLOD(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NoEOP2000History
-
getLOD.
- getLOD(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.TODProvider
-
Get the LoD (Length of Day) value.
- getLODCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.IERS2003TidalCorrection
-
Get length of day correction.
- getLODCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.IERS2010TidalCorrection
-
Get length of day correction.
- getLODCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.NoTidalCorrection
-
Get length of day correction.
- getLODCorrection() - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrection
-
Get the length of day correction.
- getLODCorrection(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrectionModel
-
Get length of day correction.
- getLODCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrectionPerThread
-
Get length of day correction.
- getLofType() - Method in class fr.cnes.sirius.patrius.attitudes.LofOffset
-
Getter for the type of Local Orbital Frame.
- getLofType() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
- getLofType() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
- getLofType() - Method in class fr.cnes.sirius.patrius.frames.LocalOrbitalFrame
-
Returns the local orbital frame type.
- getLoggedCodedEventSet() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsLogger
-
- getLoggedCodedEventSet() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiCodedEventsLogger
-
- getLoggedEvents() - Method in class fr.cnes.sirius.patrius.events.postprocessing.EventsLogger
-
Get an immutable copy of the logged events.
- getLoggedEvents() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiEventsLogger
-
Get an immutable copy of the logged events.
- getLongitude() - Method in class fr.cnes.sirius.patrius.bodies.LLHCoordinates
-
Getter for the longitude.
- getLongitude() - Method in class fr.cnes.sirius.patrius.frames.H0MinusNFrame
-
Getter for the rotation angle around the ITRF Z axis.
- getLongitude() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Getter for the longitude.
- getLongitudeToDetect() - Method in class fr.cnes.sirius.patrius.events.detectors.LongitudeDetector
-
Returns longitude to detect.
- getLosInSatFrame() - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointing
-
Getter for the LOS in satellite frame axis.
- getLosNormalInSatFrame() - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointing
-
Getter for the LOS normal axis in satellite frame.
- getLoveNumbers() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.IOceanTidesDataProvider
-
Get love numbers.
- getLoveNumbers() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTidesDataProvider
-
Get love numbers.
- getLower() - Method in class fr.cnes.sirius.patrius.math.optim.SimpleBounds
-
Gets the lower bounds.
- getLowerAngle() - Method in class fr.cnes.sirius.patrius.math.interval.AngleInterval
-
- getLowerBound() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the lower bound of the re-use interval.
- getLowerBound() - Method in class fr.cnes.sirius.patrius.math.optim.BaseMultivariateOptimizer
-
- getLowerCaseAbbreviation() - Method in enum fr.cnes.sirius.patrius.time.Month
-
Get the lower case three letters abbreviation.
- getLowerCaseName() - Method in enum fr.cnes.sirius.patrius.time.Month
-
Get the lower case full name.
- getLowerData() - Method in class fr.cnes.sirius.patrius.math.interval.GenericInterval
-
- getLowerEndPoint() - Method in class fr.cnes.sirius.patrius.math.interval.AbstractInterval
-
- getLowerEndpoint() - Method in class fr.cnes.sirius.patrius.math.interval.GenericInterval
-
- getLowestFile() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the lowest file number searched during the construction of the segment list.
- getLPOptimizationRequest() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the linear problem optimization request
- getLPOptimizationResponse() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the linear problem optimization response
- getLPrime() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean anomaly of the Sun.
- getLSa() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean Saturn longitude.
- getLst() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for lst.
- getLT() - Method in class fr.cnes.sirius.patrius.math.linear.CholeskyDecomposition
-
Returns the transpose of the matrix L of the decomposition.
- getLT() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.CholeskyFactorization
-
Returns the transpose of the matrix L of the decomposition.
- getLUr() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean Uranus longitude.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Get the true longitude argument.
- getLv() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the true longitude argument (as per equinoctial parameters).
- getLv() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the true longitude argument.
- getLVe() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean Venus longitude.
- getM() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for m coefficient.
- getMachArray() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAoAAndMach
-
Getter for the Mach numbers array.
- getMagneticMoment(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.MagneticMoment
-
Get the magnetic moment at given date, in the main frame of the spacecraft
- getMagneticMoment(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.assembly.models.MagneticMomentProvider
-
Get the magnetic moment at given date, in the main frame of the spacecraft
- getMahalanobisDistance(RealVector) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the Mahalanobis distance of a point with respect to this covariance matrix, assuming its
mean value is zero.
- getMahalanobisDistance(RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the Mahalanobis distance of a point with respect to this covariance matrix.
- getMainDirection() - Method in class fr.cnes.sirius.patrius.fieldsofview.CircularField
-
Get the main direction of the geometrical FOV.
- getMainDirection() - Method in class fr.cnes.sirius.patrius.fieldsofview.EllipticField
-
Get the main direction of the geometrical FOV.
- getMainDirection() - Method in interface fr.cnes.sirius.patrius.fieldsofview.IGeometricFieldOfView
-
Get the main direction of the geometrical FOV.
- getMainDirection() - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
-
Get the main direction of the geometrical FOV.
- getMainElement() - Method in class fr.cnes.sirius.patrius.events.detectors.LineMaskingDetector
-
Getter for the main element position point (can be null).
- getMainField() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
- getMainPart() - Method in class fr.cnes.sirius.patrius.assembly.Assembly
-
- getMainPartShape() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.VehicleSurfaceModel
-
Get the main part vehicle shape.
- getMainRole() - Method in class fr.cnes.sirius.patrius.events.detectors.LinkTypeHandler
-
Getter for the role of the main element (SpacecraftState) in the signal propagation (emitter or receiver).
- getMainShape() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Returns the main shape.
- getMainSpacecraft() - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Get the main assembly to consider.
- getMainTarget() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Getter for the main target.
- getMainTarget() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
- getMainTargetAngularRadius(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the angular radius from the sensor of the main target at a date.
- getMainTargetRadius() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
- getManeuversList() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
-
Get the custom maneuvers list.
- getMapper() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.cowell.CowellIntegrator
-
Returns the second order / first order state mapper.
- getMapper() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Get a mapper between two-dimensional Jacobians and one-dimensional additional state.
- getMars() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Mars singleton body.
- getMarsThirdBodyAttraction() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getMaskingBodies() - Method in class fr.cnes.sirius.patrius.events.detectors.LineMaskingDetector
-
Getter for the masking bodies.
- getMaskingBody() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Getter for the last masking body.
- getMaskingBodyName() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getMaskingObjectName() - Method in class fr.cnes.sirius.patrius.events.detectors.MaskingDetector
-
Get the masking object.
- getMaskingObjectName() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Getter for the masking object.
- getMaskingPartName() - Method in class fr.cnes.sirius.patrius.events.detectors.MaskingDetector
-
Get the masking part.
- getMaskingPartName() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Getter for the masking part.
- getMaskingSpacecraft() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Getter for the last masking spacecraft.
- getMaskingSpacecraftName() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getMaskingSpacecraftPartName() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getMass(String) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
-
Return the mass of the given part.
- getMass(String) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
-
Return the mass of the given part.
- getMass(String) - Method in class fr.cnes.sirius.patrius.assembly.models.MassModel
-
Return the mass of the given part.
- getMass() - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
- getMass() - Method in interface fr.cnes.sirius.patrius.assembly.properties.IInertiaProperty
-
- getMass() - Method in class fr.cnes.sirius.patrius.assembly.properties.MassProperty
-
Gets the mass of the part.
- getMass() - Method in class fr.cnes.sirius.patrius.assembly.properties.TankProperty
-
Getter for the mass.
- getMass(String) - Method in interface fr.cnes.sirius.patrius.propagation.MassProvider
-
Return the mass of the given part.
- getMass(String) - Method in class fr.cnes.sirius.patrius.propagation.SimpleMassModel
-
This model represents one part only.
- getMass(String) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the mass of the given part.
- getMass(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get the mass.
- getMass(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Get the mass.
- getMass() - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Gets the mass of the object.
- getMassCenter(Frame, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.assembly.models.IInertiaModel
-
Getter for the mass center.
- getMassCenter(Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
-
Getter for the mass center.
- getMassCenter(Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
-
Getter for the mass center.
- getMassCenter() - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
- getMassCenter() - Method in interface fr.cnes.sirius.patrius.assembly.properties.IInertiaProperty
-
- getMassModel() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
- getMassModel() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Returns the spacecraft mass model.
- getMassProperty() - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
- getMassProperty() - Method in interface fr.cnes.sirius.patrius.assembly.properties.IInertiaProperty
-
- getMassProperty() - Method in class fr.cnes.sirius.patrius.assembly.properties.TankProperty
-
Getter for the underlying mass property.
- getMassProperty() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Get mass property.
- getMassProvider() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Returns the mass provider.
- getMatrix() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldRotation
-
Get the 3X3 matrix corresponding to the instance
- getMatrix() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Rotation
-
Get the 3X3 rotation matrix corresponding to the instance.
- getMatrixScalingFactors(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.Matrix1NornRescaler
-
Scaling factors for not singular matrices.
- getMatrixScalingFactors(RealMatrix) - Method in interface fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.MatrixRescaler
-
Calculates the R and T scaling factors (matrices) for a generic matrix A so that A'(=scaled
A) = R.A.T
- getMatrixScalingFactorsSymm(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.Matrix1NornRescaler
-
Scaling factors for symmetric (not singular) matrices.
- getMatrixScalingFactorsSymm(RealMatrix) - Method in interface fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.MatrixRescaler
-
Calculates the R and T scaling factors (matrices) for a symmetric matrix A so that A'(=scaled
A) = R.A.T
- getMax() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
- getMax() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
- getMax() - Method in exception fr.cnes.sirius.patrius.math.exception.MaxCountExceededException
-
- getMax() - Method in exception fr.cnes.sirius.patrius.math.exception.NumberIsTooLargeException
-
- getMax(boolean) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns the maximum value of the matrix.
- getMax(boolean) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the maximum value of the matrix.
- getMax() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns the maximum value of the matrix.
- getMax(boolean) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns the maximum value of the matrix.
- getMax() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.SearchInterval
-
Gets the upper bound.
- getMax() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.UnivariateOptimizer
-
- getMax() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns the maximum of the available values
- getMax() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the maximum of the available values
- getMax() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
- getMax() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
maximum of the ith entries of the arrays
that correspond to each multivariate sample
- getMax() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummary
-
Returns the maximum of the available values
- getMax() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummaryValues
-
- getMax() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the maximum of the values that have been added.
- getMax() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getMax() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the maximum of the values that have been added.
- getMaxAlt() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.HarrisPriester
-
Getter for the maximal altitude for the model.
- getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
Get maximal time interval between switching function checks.
- getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get maximal time interval between switching function checks.
- getMaxCheckInterval() - Method in interface fr.cnes.sirius.patrius.events.EventDetector
-
Get maximal time interval between switching function checks.
- getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.events.MultiAbstractDetector
-
Get maximal time interval between switching function checks.
- getMaxCheckInterval() - Method in interface fr.cnes.sirius.patrius.events.MultiEventDetector
-
Get maximal time interval between switching function checks.
- getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
Get maximal time interval between switching function checks.
- getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiGenericCodingEventDetector
-
Get maximal time interval between switching function checks.
- getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Get maximal time interval between switching function checks.
- getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get maximal time interval between switching function checks.
- getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Get the maximal time interval between events handler checks.
- getMaxChunksDuration() - Method in class fr.cnes.sirius.patrius.bodies.JPLHistoricEphemerisLoader
-
Get the maximal chunks duration.
- getMaxDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.DTMInputParameters
-
Gets the available data range maximum date.
- getMaxDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
Gets the available data range maximum date.
- getMaxDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000InputParameters
-
Gets the available data range maximum date.
- getMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get maximum date at which both flux and ap values are available
- getMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get maximum date at which both flux and ap values are available
- getMaxDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get maximum date at which both flux and ap values are available
- getMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get maximum date at which both flux and ap values are available
- getMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
-
Gets the available data range maximum date.
- getMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.DTMSolarData
-
Gets the available data range maximum date.
- getMaxDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
Gets the available data range maximum date.
- getMaxDate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractBoundedPVProvider
-
- getMaxDate() - Method in class fr.cnes.sirius.patrius.propagation.AnalyticalIntegratedEphemeris
-
Get the last date of the range.
- getMaxDate() - Method in interface fr.cnes.sirius.patrius.propagation.BoundedPropagator
-
Get the last date of the range.
- getMaxDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.Ephemeris
-
Get the last date of the range.
- getMaxDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.IntegratedEphemeris
-
Get the last date of the range.
- getMaxDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
-
Get the last date of the range.
- getMaxDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Get the last date of the range.
- getMaxDegree(double, int) - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
-
Get maximum degree for given wave and order
- getMaxDegree(double, int) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
-
Get maximum degree for given wave and order
- getMaxDegree(double, int) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTidesDataProvider
-
Get maximum degree for given wave and order
- getMaxDegree() - Method in interface fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
-
Get the max degree available
- getMaxDegree() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
Get the max degree available
- getMaxEval() - Method in class fr.cnes.sirius.patrius.math.optim.MaxEval
-
Gets the maximum number of evaluations.
- getMaxEvals() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierDecompositionEngine
-
- getMaxEvaluations() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.bivariate.BivariateIntegrator
-
Returns the maximal number of function evaluations authorized during the
last run of the integrator.
- getMaxEvaluations() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Returns the maximal number of function evaluations authorized during the
last run of the integrator.
- getMaxEvaluations() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Get the maximum number of function evaluations.
- getMaxEvaluations() - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BaseUnivariateSolver
-
Get the maximum number of function evaluations.
- getMaxEvaluations() - Method in class fr.cnes.sirius.patrius.math.dfp.BracketingNthOrderBrentSolverDFP
-
Get the maximal number of function evaluations.
- getMaxEvaluations() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Get the maximal number of functions evaluations.
- getMaxEvaluations() - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Get the maximal number of functions evaluations.
- getMaxEvaluations() - Method in class fr.cnes.sirius.patrius.math.optim.BaseOptimizer
-
Gets the maximal number of function evaluations.
- getMaxEvaluations() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.BracketFinder
-
- getMaxGrowth() - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Get the maximal growth factor for stepsize control.
- getMaxGrowth() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the maximal growth factor for stepsize control.
- getMaximalCount() - Method in class fr.cnes.sirius.patrius.math.util.Incrementor
-
Gets the upper limit of the counter.
- getMaximalIterationCount() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the upper limit for the number of iterations.
- getMaximalIterationCount() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.UnivariateIntegrator
-
Get the upper limit for the number of iterations.
- getMaximalOrder() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BracketingNthOrderBrentSolver
-
Get the maximal order.
- getMaximalOrder() - Method in class fr.cnes.sirius.patrius.math.dfp.BracketingNthOrderBrentSolverDFP
-
Get the maximal order.
- getMaxImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured maximum implementation.
- getMaxImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured maximum implementation
- getMaxImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the currently configured maximum implementation
- getMaxImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured maximum implementation
- getMaxImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured maximum implementation
- getMaximumEastingValue() - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
-
Getter for the maximum value for X projected.
- getMaximumEastingValue() - Method in interface fr.cnes.sirius.patrius.projections.IProjection
-
Getter for the maximum value for X projected.
- getMaximumEastingValue() - Method in class fr.cnes.sirius.patrius.projections.Mercator
-
Getter for the maximum value for X projected.
- getMaximumLatitude() - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
-
Getter for the maximum latitude that the projection can map.
- getMaximumLatitude() - Method in interface fr.cnes.sirius.patrius.projections.IProjection
-
Getter for the maximum latitude that the projection can map.
- getMaximumLatitude() - Method in class fr.cnes.sirius.patrius.projections.Mercator
-
Getter for the maximum latitude that the projection can map.
- getMaximumNorthingValue() - Method in class fr.cnes.sirius.patrius.projections.Mercator
-
Get the maximum northing value in meters.
- getMaxIndex() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Get the index of the maximum entry.
- getMaxIter() - Method in class fr.cnes.sirius.patrius.math.optim.MaxIter
-
Gets the maximum number of evaluations.
- getMaxIter() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Getter for the maximum iteration number used in the convergence algorithm to compute the correction from the
geometric elevation.
- getMaxIteration() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the maximum number of iteration in the search algorithm.
- getMaxIteration() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the maximum number of iteration in the search algorithm
- getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
Get maximal number of iterations in the event time search.
- getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get maximal number of iterations in the event time search.
- getMaxIterationCount() - Method in interface fr.cnes.sirius.patrius.events.EventDetector
-
Get maximal number of iterations in the event time search.
- getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.events.MultiAbstractDetector
-
Get maximal number of iterations in the event time search.
- getMaxIterationCount() - Method in interface fr.cnes.sirius.patrius.events.MultiEventDetector
-
Get maximal number of iterations in the event time search.
- getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
Get maximal number of iterations in the event time search.
- getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiGenericCodingEventDetector
-
Get maximal number of iterations in the event time search.
- getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Get maximal number of iterations in the event time search.
- getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get maximal number of iterations in the event time search.
- getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Get the upper limit in the iteration count for event localization.
- getMaxIterations() - Method in class fr.cnes.sirius.patrius.math.optim.BaseOptimizer
-
Gets the maximal number of iterations.
- getMaxIterations() - Method in class fr.cnes.sirius.patrius.math.util.IterationManager
-
Returns the maximum number of iterations.
- getMaxIterSignalPropagation() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Getter for the maximum number of iterations for signal propagation when signal propagation is taken into account.
- getMaxIterSignalPropagation() - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Get the maximum number of iterations for signal propagation when signal
propagation is taken into account.
- getMaxIterSignalPropagation() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Getter for the maximum number of iterations for signal propagation when signal propagation is taken into account.
- getMaxIterSignalPropagation() - Method in class fr.cnes.sirius.patrius.forces.radiation.LightingRatio
-
Getter for the maximum number of iterations for signal propagation when signal propagation is taken into account.
- getMaxIterSignalPropagation() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Getter for the maximum number of iterations for signal propagation when signal propagation is taken into account.
- getMaxNorm() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the distance from center to farthest vertex to center of body.
- getMaxOptimalDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
- getMaxOrder(double) - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
-
Get maximum order for given wave
- getMaxOrder(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
-
Get maximum order for given wave
- getMaxOrder(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTidesDataProvider
-
Get maximum order for given wave
- getMaxOrder() - Method in enum fr.cnes.sirius.patrius.utils.AngularDerivativesFilter
-
Get the maximum derivation order.
- getMaxOrder() - Method in enum fr.cnes.sirius.patrius.utils.CartesianDerivativesFilter
-
Get the maximum derivation order.
- getMaxOrders() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Return the array with the highest trigonometric orders available.
- getMaxRescaledUB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the maximum rescaled lower bound
- getMaxSampleDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
- getMaxSize() - Method in class fr.cnes.sirius.patrius.tools.cache.FIFOThreadSafeCache
-
Getter for the maximum size of the cache.
- getMaxSlope() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the maximum angle between the normal to a facet of the body and the vector from the
origin to the centre of the facet.
- getMaxSlots() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the maximum number of independent cached time slots.
- getMaxSpan() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the maximum duration span in seconds of one slot.
- getMaxStep() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Get the maximal step.
- getMaxTime() - Method in class fr.cnes.sirius.patrius.utils.TimeIt
-
Returns the maximum time it takes to perform the function to benchmark (evaluated on a batch of
N
loops).
- getMaxTrigonometricOrder() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DParameterModel
-
Return the highest trigonometric order.
- getMaxValue() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Get the value of the maximum entry.
- getMaxX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
- getMaxY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
- getMean() - Method in class fr.cnes.sirius.patrius.math.distribution.ExponentialDistribution
-
Access the mean.
- getMean() - Method in class fr.cnes.sirius.patrius.math.distribution.NormalDistribution
-
Access the mean.
- getMean() - Method in class fr.cnes.sirius.patrius.math.distribution.PoissonDistribution
-
Get the mean for the distribution.
- getMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
- getMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
- getMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
- getMean() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
mean of the ith entries of the arrays
that correspond to each multivariate sample
- getMean() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummary
-
- getMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummaryValues
-
- getMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the mean of the values that have been added.
- getMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getMean() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the mean of the values that have been added.
- getMeanAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the mean anomaly.
- getMeanAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the mean anomaly.
- getMeanAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Get the mean anomaly.
- getMeanAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Get the mean anomaly.
- getMeanAnomaly() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the mean anomaly in [0, 2π].
- getMeanAnomalyInit() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getMeanAp(AbsoluteDate, AbsoluteDate, SolarActivityDataProvider) - Static method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityToolbox
-
Compute mean flux between given dates (rectangular rule)
- getMeanAtomicMass() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AtmosphereData
-
Returns the mean atomic mass or the molar mass.
- getMeanDeltaV(Vector3D) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.GatesModel
-
Computes the mean ΔV vector of the distribution modeling the uncertainty on a
maneuver's magnitude and direction.
- getMeanDeltaV(Vector3D, double) - Static method in class fr.cnes.sirius.patrius.forces.maneuvers.GatesModel
-
Computes the mean ΔV vector of the distribution modeling the uncertainty on a
maneuver's magnitude and direction.
- getMeanFlux(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.DTMInputParameters
-
Get the value of the mean solar flux.
- getMeanFlux(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000InputParameters
-
Get the 81 day average of F10.7 flux.
- getMeanFlux(AbsoluteDate, AbsoluteDate, SolarActivityDataProvider) - Static method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityToolbox
-
Compute mean flux between given dates using trapezoidal rule
- getMeanFlux(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
-
Get the 81 day average of F10.7 flux.
- getMeanFlux(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.ContinuousMSISE2000SolarData
-
Get the 81 day average of F10.7 flux.
- getMeanFlux(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.DTMSolarData
-
Get the value of the mean solar flux.
- getMeanFlux(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
Get the value of the mean solar flux.
- getMeanFlux(AbsoluteDate, double[]) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Compute weighted mean flux, given a weights array.
- getMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured mean implementation.
- getMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured mean implementation
- getMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the currently configured mean implementation
- getMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured mean implementation
- getMeanImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured mean implementation
- getMeanMolarMass(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
Getter for the mean molar mass at the local point.
- getMeanMolarMass() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.JacchiaOutput
-
Getter for the atmospheric mean molar mass.
- getMeanMolarMassFunction() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77Data
-
Getter for the 2D interpolator for mean molar mass map.
- getMeanMotion() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the mean motion.
- getMeanMotion() - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
-
Returns mean motion.
- getMeanMotion() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaPartialDerivativesEquations
-
Returns mean motion from state transition matrix.
- getMeanMotionFirstDerivative() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the mean motion first derivative.
- getMeanMotionSecondDerivative() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the mean motion second derivative.
- getMeanMotionSTM() - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
-
Returns mean motion from STM (STM = state transition matrix).
- getMeans() - Method in class fr.cnes.sirius.patrius.math.distribution.MultivariateNormalDistribution
-
Gets the mean vector.
- getMeanSquareError() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
Returns the sum of squared errors divided by the degrees of freedom, usually abbreviated MSE.
- getMeanSquareError() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the sum of squared errors divided by the degrees of freedom,
usually abbreviated MSE.
- getMeanTime() - Method in class fr.cnes.sirius.patrius.utils.TimeIt
-
Returns the arithmetic mean of the computation time it takes to perform the function to benchmark (evaluated on a
batch of
N loops).
- getMeasurementDimension() - Method in class fr.cnes.sirius.patrius.math.filter.KalmanFilter
-
Returns the dimension of the measurement vector.
- getMeasurementMatrix() - Method in class fr.cnes.sirius.patrius.math.filter.DefaultMeasurementModel
-
Returns the measurement matrix.
- getMeasurementMatrix() - Method in interface fr.cnes.sirius.patrius.math.filter.MeasurementModel
-
Returns the measurement matrix.
- getMeasurementNoise() - Method in class fr.cnes.sirius.patrius.math.filter.DefaultMeasurementModel
-
Returns the measurement noise matrix.
- getMeasurementNoise() - Method in interface fr.cnes.sirius.patrius.math.filter.MeasurementModel
-
Returns the measurement noise matrix.
- getMedian() - Method in class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Access the median.
- getMeq() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the number of equalities.
- getMercury() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Mercury singleton body.
- getMergedIntervals() - Method in class fr.cnes.sirius.patrius.math.interval.ComparableIntervalsList
-
Merges the intervals of the list that overlap and returns the list of merged intervals.
- getMergedIntervals() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateIntervalsList
-
Merges the intervals of the list that overlap and returns the list of merged intervals.
- getMeritFactor() - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
-
- getMeshProvider() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the mesh provider.
- getMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathArithmeticException
- getMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathIllegalArgumentException
- getMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathIllegalStateException
- getMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathRuntimeException
- getMessage() - Method in exception fr.cnes.sirius.patrius.math.exception.MathUnsupportedOperationException
- getMessage() - Method in class fr.cnes.sirius.patrius.math.exception.util.ExceptionContext
-
Gets the default message.
- getMessage(Locale) - Method in class fr.cnes.sirius.patrius.math.exception.util.ExceptionContext
-
Gets the message in a specified locale.
- getMessage(Locale, String) - Method in class fr.cnes.sirius.patrius.math.exception.util.ExceptionContext
-
Gets the message in a specified locale.
- getMessage(Locale) - Method in exception fr.cnes.sirius.patrius.utils.exception.PatriusException
-
Gets the message in a specified locale.
- getMessage() - Method in exception fr.cnes.sirius.patrius.utils.exception.PatriusException
- getMeteoConditionsProvider() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AbstractMeteoBasedCorrectionFactory.MeteoBasedKey
-
Getter for the meteorological conditions provider.
- getMeteoConditionsProvider() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Getter for the meteo conditions provider.
- getMeteorologicalConditions(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.signalpropagation.ConstantMeteorologicalConditionsProvider
-
Returns the meteorological conditions at a given date.
- getMeteorologicalConditions(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.signalpropagation.MeteorologicalConditionsProvider
-
Returns the meteorological conditions at a given date.
- getMid() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.BracketFinder
-
- getMiddleDate() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Compute the middle date.
- getMieq() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the number of inequalities.
- getMilliInWeek() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Returns the number of milliseconds since week (corresponding to a GPS date).
- getMin() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
- getMin() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
- getMin() - Method in exception fr.cnes.sirius.patrius.math.exception.NumberIsTooSmallException
-
- getMin(boolean) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns the minimum value of the matrix.
- getMin(boolean) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the minimum value of the matrix.
- getMin() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns the minimum value of the matrix.
- getMin(boolean) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns the minimum value of the matrix.
- getMin() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.SearchInterval
-
Gets the lower bound.
- getMin() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.UnivariateOptimizer
-
- getMin() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns the minimum of the available values
- getMin() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the minimum of the available values
- getMin() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
- getMin() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
minimum of the ith entries of the arrays
that correspond to each multivariate sample
- getMin() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummary
-
Returns the minimum of the available values
- getMin() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummaryValues
-
- getMin() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the minimum of the values that have been added.
- getMin() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getMin() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the minimum of the values that have been added.
- getMinAbscissa() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Get the line minimum abscissa.
- getMinAlt() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.HarrisPriester
-
Getter for the minimal altitude for the model.
- getMinDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.DTMInputParameters
-
Gets the available data range minimum date.
- getMinDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
Gets the available data range minimum date.
- getMinDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000InputParameters
-
Gets the available data range minimum date.
- getMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Get minimum date at which both flux and ap values are available
- getMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Get minimum date at which both flux and ap values are available
- getMinDate() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Get minimum date at which both flux and ap values are available
- getMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get minimum date at which both flux and ap values are available
- getMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
-
Gets the available data range minimum date.
- getMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.DTMSolarData
-
Gets the available data range minimum date.
- getMinDate() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
Gets the available data range minimum date.
- getMinDate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractBoundedPVProvider
-
- getMinDate() - Method in class fr.cnes.sirius.patrius.propagation.AnalyticalIntegratedEphemeris
-
Get the first date of the range.
- getMinDate() - Method in interface fr.cnes.sirius.patrius.propagation.BoundedPropagator
-
Get the first date of the range.
- getMinDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.Ephemeris
-
Get the first date of the range.
- getMinDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.IntegratedEphemeris
-
Get the first date of the range.
- getMinDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
-
Get the first date of the range.
- getMinDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Get the first date of the range.
- getMinDegree(double, int) - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
-
Get min degree for given wave and order
- getMinDegree(double, int) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
-
Get min degree for given wave and order
- getMinDegree(double, int) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTidesDataProvider
-
Get min degree for given wave and order
- getMinimalIterationCount() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the min limit for the number of iterations.
- getMinimalIterationCount() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.UnivariateIntegrator
-
Get the min limit for the number of iterations.
- getMinimalToleratedApparentElevation() - Method in interface fr.cnes.sirius.patrius.signalpropagation.AngularCorrection
-
Getter for the minimal tolerated apparent elevation for this model (some models cannot compute correction for too
low elevations).
- getMinimalToleratedApparentElevation() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Getter for the minimal tolerated apparent elevation for this model (some models cannot compute correction for too
low elevations).
- getMinimalToleratedApparentElevation() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AzoulayModel
-
Getter for the minimal tolerated apparent elevation for this model (some models cannot compute correction for too
low elevations).
- getMinImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured minimum implementation.
- getMinImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured minimum implementation
- getMinImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the currently configured minimum implementation
- getMinImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured minimum implementation
- getMinImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured minimum implementation
- getMinIndex() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Get the index of the minimum entry.
- getMinMaskingDistance(SpacecraftState, SensorModel, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractStationToSatDetector
-
Computes minimum masking distance by either body or spacecraft defined in sensor model.
- getMinNorm() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the distance from center to closest vertex to center of body.
- getMinOptimalDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
- getMinPts() - Method in class fr.cnes.sirius.patrius.math.stat.clustering.DBSCANClusterer
-
Returns the minimum number of points needed for a cluster.
- getMinReduction() - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Get the minimal reduction factor for stepsize control.
- getMinReduction() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the minimal reduction factor for stepsize control.
- getMinRescaledLB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the minimum rescaled lower bound
- getMinSampleDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
- getMinStep() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Get the minimal step.
- getMinTime() - Method in class fr.cnes.sirius.patrius.utils.TimeIt
-
Returns the minimum computation time it takes to perform the function to benchmark (evaluated on a batch of
N loops).
- getMinus() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BSPTree
-
Get the tree on the minus side of the cut hyperplane.
- getMinus() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Get the part of the sub-hyperplane on the minus side of the splitting hyperplane.
- getMinute() - Method in class fr.cnes.sirius.patrius.time.TimeComponents
-
Get the minute number.
- getMinValue() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Get the value of the minimum entry.
- getMinX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
- getMinY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
- getMJD() - Method in class fr.cnes.sirius.patrius.time.DateComponents
-
Get the modified julian day.
- getMOD(boolean) - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the MOD reference frame.
- getMode() - Method in class fr.cnes.sirius.patrius.math.distribution.TriangularDistribution
-
Returns the mode c of this distribution.
- getMode() - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
Returns the data generation mode.
- getMode() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Get the current operating mode of the propagator.
- getMode() - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get the current operating mode of the propagator.
- getMode() - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Get the current operating mode of the propagator.
- getMode() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the current operating mode of the propagator.
- getMode() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get the current operating mode of the propagator.
- getMode() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Get the current operating mode of the propagator.
- getMode() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get the current operating mode of the propagator.
- getModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Getter for the internal precession nutation model.
- getModelFunction() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.ModelFunction
-
Gets the model function to be optimized.
- getModelFunctionJacobian() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.ModelFunctionJacobian
-
Gets the Jacobian of the model function to be optimized.
- getModelName() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Getter for the model name.
- getModels() - Method in interface fr.cnes.sirius.patrius.models.earth.GeoMagneticDataProvider
-
- getModels() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticModelReader
-
- getModifiedRodrigues(double) - Method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Convert rotation, rate and acceleration to modified Rodrigues vector and derivatives.
- getModifiedRodrigues(double, boolean) - Method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Convert rotation, rate and acceleration to modified Rodrigues vector and derivatives.
- getMODPrecession(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Getter for the MOD precession transformation from GCRF/EME2000 to MOD at provided date.
- getMODPrecession(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Getter for the MOD precession transformation from GCRF/EME2000 to MOD at provided date.
- getMODPrecession(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecession
-
Getter for the MOD precession transformation from GCRF/EME2000 to MOD at provided date.
- getMODPrecession(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.modprecession.MODPrecessionModel
-
Getter for the MOD precession transformation from GCRF/EME2000 to MOD at provided date.
- getMODPrecessionModel() - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Get the MOD precession model.
- getMODPrecessionModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Get the MOD precession model.
- getMolarMass() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaDragCoefInput
-
Getter for mean molar mass of the atmosphere.
- getMomentum() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.PVCoordinates
-
Gets the momentum.
- getMonth() - Method in class fr.cnes.sirius.patrius.time.DateComponents
-
Get the month.
- getMonth(int) - Static method in enum fr.cnes.sirius.patrius.time.Month
-
Get the month corresponding to a number.
- getMonthEnum() - Method in class fr.cnes.sirius.patrius.time.DateComponents
-
Get the month as an enumerate.
- getMoon() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Moon singleton body.
- getMoon() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
-
Get the Moon.
- getMoonThirdBodyAttraction() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getMu() - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractGravityModel
-
Get the central attraction coefficient.
- getMu() - Method in interface fr.cnes.sirius.patrius.forces.gravity.GravityModel
-
Get the central attraction coefficient.
- getMu() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.GridGravityModel
-
Get the central attraction coefficient.
- getMu() - Method in interface fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsProvider
-
Get the central body attraction coefficient.
- getMu() - Method in class fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsReader
-
Get the central body attraction coefficient.
- getMu() - Method in interface fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
-
Get the central body attraction coefficient.
- getMu() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
Get the central body attraction coefficient.
- getMu() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the calibration parameter for line search
- getMu() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the calibration parameter for line search
- getMu() - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
- getMu() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the central acceleration constant.
- getMu() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AbstractOrbitalParameters
-
Getter for the central acceleration constant.
- getMu() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Getter for the central acceleration constant.
- getMu() - Method in enum fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSType
-
- getMu() - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
- getMu() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Returns the standard gravitational parameter.
- getMu(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the central attraction coefficient μ.
- getMu() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get the central attraction coefficient μ.
- getMu() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the central attraction coefficient.
- getMultiDetector() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiCodedEventsLogger.MultiLoggedCodedEvent
-
- getMultiDetector() - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedMultiEventDetector
-
Get the multiDetector object.
- getMultIndirection() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Returns indirection arrays for multiplication.
- getMultiOrbitalCovariance(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.covariance.BasicMultiOrbitalCovarianceProvider
-
- getMultiOrbitalCovariance(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.covariance.MultiOrbitalCovarianceProvider
-
- getMultiplicativeFactor() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.VehicleSurfaceModel
-
Get the multiplicative factor applied to the reference surface as a parameter.
- getMultiplicativeFactor() - Method in class fr.cnes.sirius.patrius.forces.drag.DragForce
-
Getter for the multiplicative factor.
- getMultiplicativeFactor(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.drag.DragForce
-
Getter for the multiplicative factor used at construction.
- getMultiplicativeFactor() - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
Get the force multiplicative factor.
- getMultiplicativeFactor() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Getter for the multiplicative factor.
- getMultiplicativeFactorParameter() - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
Get the force multiplicative factor parameter
- getMultiplicators() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationResponse
-
Returns the Lagrangian multipliers.
- getMuParameter() - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractGravityModel
-
Returns the gravitational coefficient as a parameter.
- getMuParameter() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionData
-
Returns the gravitational constant of the body as a parameter.
- getMutationPolicy() - Method in class fr.cnes.sirius.patrius.math.genetics.GeneticAlgorithm
-
Returns the mutation policy.
- getMutationRate() - Method in class fr.cnes.sirius.patrius.math.genetics.GeneticAlgorithm
-
Returns the mutation rate.
- getN() - Method in class fr.cnes.sirius.patrius.frames.H0MinusNFrame
-
Getter for the reference date shift.
- getN() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialSplineFunction
-
Get the number of spline segments.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.Covariance
-
Returns the number of observations (length of covariate vectors)
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.StorelessCovariance
-
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns the number of available values
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the number of available values
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Kurtosis
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Mean
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Skewness
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Variance
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.VectorialCovariance
-
Get the number of vectors in the sample.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.VectorialMean
-
Get the number of vectors in the sample.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the number of available values
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Max
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Min
-
Returns the number of values that have been added.
- getN() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns the number of available values
- getN() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummary
-
Returns the number of available values
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummaryValues
-
- getN() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StorelessUnivariateStatistic
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Product
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Sum
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfLogs
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfSquares
-
Returns the number of values that have been added.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the number of available values
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the number of available values
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the number of available values
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the number of available values
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.regression.MillerUpdatingRegression
-
Gets the number of observations added to the regression model.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
Returns the number of observations added to the regression model.
- getN() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the number of observations that have been added to the model.
- getN() - Method in interface fr.cnes.sirius.patrius.math.stat.regression.UpdatingMultipleLinearRegression
-
Returns the number of observations added to the regression model.
- getN() - Method in class fr.cnes.sirius.patrius.math.util.Combinations
-
Gets the size of the set from which combinations are drawn.
- getN() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the mean motion.
- getN() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the mean motion.
- getN() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the mean motion.
- getN() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the mean motion.
- getN() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the mean motion.
- getN() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the mean motion.
- getN() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the mean motion.
- getN() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the mean motion.
- getN() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Get the mean motion.
- getN() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for n coefficient.
- getN() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the mean motion.
- getNadir() - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the nadir direction of topocentric frame, expressed in the body frame of body shape to which the frame
center point is attached.
- getName() - Method in class fr.cnes.sirius.patrius.assembly.AbstractPart
- getName() - Method in interface fr.cnes.sirius.patrius.assembly.IPart
-
- getName() - Method in class fr.cnes.sirius.patrius.assembly.models.SecondarySpacecraft
-
- getName() - Method in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
-
Get the name of the additional equation.
- getName() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Getter for the name of the point.
- getName() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
Getter for the name of the shape.
- getName() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
Get the name of the celestial point.
- getName() - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Getter for the name of the point.
- getName() - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Getter for the name of the shape.
- getName(String) - Method in class fr.cnes.sirius.patrius.bodies.BSPCelestialBodyLoader
-
Returns name of body as known by the loader corresponding to PATRIUS body name.
- getName() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Getter for the name of the body.
- getName(String) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyLoader
-
Returns name of body as known by the loader corresponding to PATRIUS body name.
- getName() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialPoint
-
Get the name of the celestial point.
- getName() - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Getter for the name of the body.
- getName(String) - Method in class fr.cnes.sirius.patrius.bodies.JPLCelestialBodyLoader
-
Returns name of body as known by the loader corresponding to PATRIUS body name.
- getName() - Method in class fr.cnes.sirius.patrius.bodies.LLHCoordinates
-
Getter for the name of the coordinates.
- getName() - Method in class fr.cnes.sirius.patrius.bodies.mesh.ObjMeshLoader
-
Getter for the name of the loaded object.
- getName() - Method in enum fr.cnes.sirius.patrius.bodies.PredefinedEphemerisType
-
Returns the JPL/PATRIUS name.
- getName(String) - Method in class fr.cnes.sirius.patrius.bodies.UserCelestialBodyLoader
-
Returns name of body as known by the loader corresponding to PATRIUS body name.
- getName() - Method in class fr.cnes.sirius.patrius.fieldsofview.AzimuthElevationField
- getName() - Method in class fr.cnes.sirius.patrius.fieldsofview.BooleanField
- getName() - Method in class fr.cnes.sirius.patrius.fieldsofview.CircularField
- getName() - Method in class fr.cnes.sirius.patrius.fieldsofview.EllipticField
- getName() - Method in interface fr.cnes.sirius.patrius.fieldsofview.IFieldOfView
-
- getName() - Method in class fr.cnes.sirius.patrius.fieldsofview.InvertField
- getName() - Method in class fr.cnes.sirius.patrius.fieldsofview.OmnidirectionalField
- getName() - Method in class fr.cnes.sirius.patrius.fieldsofview.PyramidalField
- getName() - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
- getName() - Method in class fr.cnes.sirius.patrius.fieldsofview.SectorField
- getName() - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the name.
- getName() - Method in enum fr.cnes.sirius.patrius.frames.PredefinedFrameType
-
Get the name of the frame.
- getName() - Method in enum fr.cnes.sirius.patrius.math.geometry.euclidean.twod.EnumPolygon
-
Getter for the enumerate name.
- getName() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Get the name of the method.
- getName() - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Get the name of the method.
- getName() - Method in exception fr.cnes.sirius.patrius.math.ode.UnknownParameterException
-
- getName() - Method in class fr.cnes.sirius.patrius.math.parameter.FieldDescriptor
-
Gets the name of the descriptor.
- getName() - Method in class fr.cnes.sirius.patrius.math.parameter.Parameter
-
Gets the parameter name, which is a concatenation of field values currently associated with
the parameter descriptor (printed in reverse order by default).
- getName(boolean) - Method in class fr.cnes.sirius.patrius.math.parameter.Parameter
-
Gets the parameter name, which is a concatenation of field values currently associated with
the parameter descriptor.
- getName(String) - Method in class fr.cnes.sirius.patrius.math.parameter.Parameter
-
Gets the parameter name, which is a concatenation of field values currently associated with
the parameter descriptor (printed in reverse order by default).
- getName(String, boolean) - Method in class fr.cnes.sirius.patrius.math.parameter.Parameter
-
Gets the parameter name, which is a concatenation of field values currently associated with
the parameter descriptor.
- getName() - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Gets the name of this parameter descriptor, which is comprised of the associated field values
separated by an underscore (printed in reverse order by default).
- getName(boolean) - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Gets the name of this parameter descriptor, which is comprised of the associated field values
separated by an underscore.
- getName(String) - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Gets the name of this parameter descriptor, which is comprised of the associated field values
separated by the specified string (printed in reverse order by default).
- getName(String, boolean) - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Gets the name of this parameter descriptor, which is comprised of the associated field values
separated by the specified string.
- getName() - Method in enum fr.cnes.sirius.patrius.projections.EnumLineProperty
-
Get the line property's name.
- getName() - Method in interface fr.cnes.sirius.patrius.propagation.AdditionalStateProvider
-
Get the name of the additional state.
- getName() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Get the name of the additional state.
- getName() - Method in interface fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquations
-
Get the name of the additional state.
- getName() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AttitudeEquation
-
Get the name of the additional equation.
- getName() - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the name of the partial Jacobians.
- getName() - Method in class fr.cnes.sirius.patrius.propagation.SimpleAdditionalStateProvider
-
Get the name of the additional state.
- getName() - Method in interface fr.cnes.sirius.patrius.stela.propagation.StelaAdditionalEquations
-
Get the name of the additional state.
- getName() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAttitudeAdditionalEquations
-
Get the name of the additional equation.
- getName() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaPartialDerivativesEquations
-
Get the name of the additional state.
- getName() - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Gets the name of the object.
- getName() - Method in class fr.cnes.sirius.patrius.time.GalileoScale
-
Get the name time scale.
- getName() - Method in class fr.cnes.sirius.patrius.time.GMSTScale
-
Get the name time scale.
- getName() - Method in class fr.cnes.sirius.patrius.time.GPSScale
-
Get the name time scale.
- getName() - Method in class fr.cnes.sirius.patrius.time.TAIScale
-
Get the name time scale.
- getName() - Method in class fr.cnes.sirius.patrius.time.TCBScale
-
Get the name time scale.
- getName() - Method in class fr.cnes.sirius.patrius.time.TCGScale
-
Get the name time scale.
- getName() - Method in class fr.cnes.sirius.patrius.time.TDBScale
-
Get the name time scale.
- getName() - Method in interface fr.cnes.sirius.patrius.time.TimeScale
-
Get the name time scale.
- getName() - Method in class fr.cnes.sirius.patrius.time.TTScale
-
Get the name time scale.
- getName() - Method in class fr.cnes.sirius.patrius.time.UT1Scale
-
Get the name time scale.
- getName() - Method in class fr.cnes.sirius.patrius.time.UTCScale
-
Get the name time scale.
- getNameOfArray() - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.FindArraysDAF
-
Return (get) the name for the current array in the current DAF.
- getNanStrategy() - Method in class fr.cnes.sirius.patrius.math.stat.ranking.NaturalRanking
-
Return the NaNStrategy
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.BSPCelestialBodyLoader.SSBEphemeris
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.EarthEphemeris
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.covariance.BasicOrbitalCovarianceProvider
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.groundstation.GeometricStationAntenna
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractBoundedPVProvider
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.ConstantPVCoordinatesProvider
-
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSPVCoordinates
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.orbits.pvcoordinates.PVCoordinatesProvider
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNativeFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Getter for the frame in which the time-stamped PVCoordinates are defined.
- getNativeFrame(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Get the native frame, i.e. the raw frame in which PVCoordinates are expressed before transformation to user
output frame.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeLawLeg
-
Returns the nature of the leg.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Returns the nature of the leg.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.orientations.AbstractOrientationAngleLeg
-
Returns the nature of the leg.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLegsSequence
-
Get the legs sequence nature.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfileSequence
-
Returns the nature of the leg.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAttitudeProfile
-
Returns the nature of the leg.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Returns the nature of the leg.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
Returns the nature of the leg.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.RelativeTabulatedAttitudeLeg
-
Returns the nature of the leg.
- getNature() - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Returns the nature of the leg.
- getNature() - Method in enum fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialType
-
Getter for the nature of the polynomial function.
- getNature() - Method in interface fr.cnes.sirius.patrius.utils.legs.Leg
-
Returns the nature of the leg.
- getNbColumns() - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Getter for the number of columns in the table.
- getNBOccurredEvents() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Getter for the number of the occurred events.
- getNbPoints() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.FiniteDifferencesDifferentiator
-
Get the number of points to use.
- getNbPointsAfter() - Method in class fr.cnes.sirius.patrius.math.filter.FIRFilter
-
Getter for the number of points after the computation date to be used by the filter.
- getNbPointsBefore() - Method in class fr.cnes.sirius.patrius.math.filter.FIRFilter
-
Getter for the number of points before the computation date to be used by the filter.
- getnDouble() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.FileRecordDAF
-
Getter for the number of double precision components in summaries.
- getNeighbors(Triangle, double) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the neighbors of provided triangle whose center is closer than provided distance of provided triangle
center.
- getNeighbors(Triangle, int) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the neighbors of provided triangle whose distance in terms of triangle is closer or equal to provided
order of "neighborhood".
- getNeighbors(BodyPoint, double) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the neighbors of provided ellipsoid point whose center is closer than provided distance.
- getNeighbors(BodyPoint, int) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the neighbor triangles of provided body point which are closer or equal to provided order of
"neighborhood".
- getNeighbors(Vector3D, double) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the neighbors of provided cartesian point whose center is closer than provided distance.
- getNeighbors(Vector3D, int) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the neighbor triangles of provided cartesian point which are closer or equal to provided order of
"neighborhood".
- getNeighbors() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Getter for the triangle neighbors (i.e. which have a side in common).
- getNeighbors() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Vertex
-
Returns the triangle neighbors (i.e.
- getNeighbors(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the entries surrounding a central date.
- getNeighborsSize() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
- getNeptune() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Neptune singleton body.
- getNeverEnlightenedTriangles(List<AbsoluteDate>, PVCoordinatesProvider) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the list of triangles never enlightened by the Sun at provided dates.
- getNeverVisibleTriangles(List<SpacecraftState>, IFieldOfView) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the list of triangles never visible from the satellite field of view during the whole ephemeris.
- getNewOrphanFrame(String) - Static method in class fr.cnes.sirius.patrius.frames.OrphanFrame
-
This method creates an Orphan Frame.
- getNewSlotQuantumGap() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get quantum gap above which a new slot is created instead of extending an existing one.
- getNewtonCoefficients() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of coefficients in Newton form formula.
- getNext() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.AVLTree.Node
-
Get the node containing the next larger or equal element.
- getNext() - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
Returns the next generated value, generated according
to the mode value (see MODE constants).
- getNextValue() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Generates a random value from this distribution.
- getnInt() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.FileRecordDAF
-
Getter for the number of integer components in a summary.
- getNonRotatingLaw() - Method in class fr.cnes.sirius.patrius.attitudes.SpinStabilized
-
Getter for the underlying non-rotating attitude law.
- getNorm() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Computes the norm of the quaternion.
- getNorm() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Get the L2 norm for the vector.
- getNorm() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Get the L2 norm for the vector.
- getNorm() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCoordinates
-
Get the norm.
- getNorm() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the L2 norm for the vector.
- getNorm() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Get the L2 norm for the vector.
- getNorm() - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Get the L2 norm for the vector.
- getNorm() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
- getNorm() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Returns the L2 norm of the vector.
- getNorm() - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
- getNorm() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
- getNorm() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
- getNorm() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Returns the L2 norm of the vector.
- getNorm() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Returns the L2 norm of the matrix.
- getNorm1() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Get the L1 norm for the vector.
- getNorm1() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Get the L1 norm for the vector.
- getNorm1() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the L1 norm for the vector.
- getNorm1() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Get the L1 norm for the vector.
- getNorm1() - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Get the L1 norm for the vector.
- getNormal() - Method in class fr.cnes.sirius.patrius.assembly.properties.features.Facet
-
- getNormal() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Get the normal direction, expressed in body frame, to the local horizontal plane at the point position, oriented
towards the outside.
- getNormal() - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Get the normal direction, expressed in body frame, to the local horizontal plane at the point position, oriented
towards the outside.
- getNormal(AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Returns the normal direction expressed in the provided frame.
- getNormal() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Getter for the normal to the triangle.
- getNormal() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractEllipse
-
- getNormal(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Computes the normal vector to the surface in local basis
- getNormal(Vector3D) - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.IEllipsoid
-
Computes the normal vector to the surface in local basis
- getNormal() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Get the normalized normal vector.
- getNormal(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Computes the normal vector to the surface
- getNormalCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
-
Get the normal force parametrizable function.
- getNormalHeight() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Returns the normal height, computed as the signed distance between the closestPointOnShape and this:
Positive distance if this is outside the shape,
Negative distance if this is inside the shape,
Null distance if this is on the shape.
- getNormalHeight() - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Returns the normal height, computed as the signed distance between the closestPointOnShape and this:
Positive distance if this is outside the shape,
Negative distance if this is inside the shape,
Null distance if this is on the shape.
- getNormalisedTargetVectorInSensorFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the target vector at a date in the sensor's frame.
- getNormalization() - Method in class fr.cnes.sirius.patrius.math.transform.AbstractFastFourierTransformer
-
Gets the private attribute normalization.
- getNormalizedCCoefs(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTides
-
Get normalized C coefficients table
- getNormalizedSCoefs(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTides
-
Get normalized S coefficients table
- getNormalVector() - Method in class fr.cnes.sirius.patrius.events.detectors.PlaneCrossingDetector
-
Getter for the normal vector to the plane used for plane definition.
- getNormInf(UnivariateFunction, UnivariateFunction, double[]) - Static method in class fr.cnes.sirius.patrius.math.analysis.ErrorEvaluationFunctionUtils
-
Compute the L∞ norm (worst value) between the function to evaluate and the approximated function
at the considered abscissas.
- getNormInf(double[], double[], UnivariateFunction) - Static method in class fr.cnes.sirius.patrius.math.analysis.ErrorEvaluationFunctionUtils
-
Compute the L∞ norm (worst value) between the function to evaluate and the approximated function
at the considered abscissas.
- getNormInf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Get the L∞ norm for the vector.
- getNormOfResidual() - Method in class fr.cnes.sirius.patrius.math.linear.DefaultIterativeLinearSolverEvent
-
Returns the norm of the residual.
- getNormOfResidual() - Method in class fr.cnes.sirius.patrius.math.linear.IterativeLinearSolverEvent
-
Returns the norm of the residual.
- getNormSq() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Get the square of the norm for the vector.
- getNormSq() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Get the square of the norm for the vector.
- getNormSq() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the square of the norm for the vector.
- getNormSq() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Get the square of the norm for the vector.
- getNormSq() - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Get the square of the norm for the vector.
- getNorth() - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the north direction of topocentric frame, expressed in the body frame of body shape to which the frame
center point is attached.
- getNotFeasibleInitialPoint() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get a not-feasible starting point for the minimum search
- getNotFeasibleInitialPoint() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the not feasible initial point
- getNotLarger(T) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.AVLTree
-
Get the node whose element is not larger than the reference object.
- getNotSmaller(T) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.AVLTree
-
Get the node whose element is not smaller than the reference object.
- getNSteps() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdamsNordsieckTransformer
-
Get the number of steps of the method
(excluding the one being computed).
- getnSummariesCurrSummaryRecord() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Getter for the number of summaries in the current summary record.
- getNumber() - Method in enum fr.cnes.sirius.patrius.time.Month
-
Get the month number.
- getNumberOfElements() - Method in class fr.cnes.sirius.patrius.math.distribution.ZipfDistribution
-
Get the number of elements (e.g. corpus size) for the distribution.
- getNumberOfEpochs() - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
Returns the number of epochs contained in this orbit file.
- getNumberOfEpochs() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the number of epochs contained in this orbit file.
- getNumberOfParameters() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
Returns the number of parameters estimated in the model.
- getNumberOfPoints() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.gauss.GaussIntegrator
-
- getNumberOfRoots() - Method in class fr.cnes.sirius.patrius.math.complex.RootsOfUnity
-
Returns the number of roots of unity currently stored.
- getNumberOfSuccesses() - Method in class fr.cnes.sirius.patrius.math.distribution.HypergeometricDistribution
-
Access the number of successes.
- getNumberOfSuccesses() - Method in class fr.cnes.sirius.patrius.math.distribution.PascalDistribution
-
Access the number of successes for this distribution.
- getNumberOfTrials() - Method in class fr.cnes.sirius.patrius.math.distribution.BinomialDistribution
-
Access the number of trials for this distribution.
- getNumElements() - Method in interface fr.cnes.sirius.patrius.math.util.DoubleArray
-
Returns the number of elements currently in the array.
- getNumElements() - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Returns the number of elements currently in the array.
- getNumerator() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Access the numerator as a BigInteger.
- getNumerator() - Method in class fr.cnes.sirius.patrius.math.fraction.Fraction
-
Access the numerator.
- getNumeratorAsInt() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Access the numerator as a int.
- getNumeratorAsLong() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Access the numerator as a long.
- getNumeratorDegreesOfFreedom() - Method in class fr.cnes.sirius.patrius.math.distribution.FDistribution
-
Access the numerator degrees of freedom.
- getNumeratorFormat() - Method in class fr.cnes.sirius.patrius.math.fraction.AbstractFormat
-
Access the numerator format.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.BetaDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.BinomialDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.ExponentialDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.FDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.HypergeometricDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in interface fr.cnes.sirius.patrius.math.distribution.IntegerDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.LogNormalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.NormalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.PascalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.PoissonDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in interface fr.cnes.sirius.patrius.math.distribution.RealDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.TDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.TriangularDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformIntegerDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformRealDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.distribution.ZipfDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.BetaDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.BinomialDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.ExponentialDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.FDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.HypergeometricDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in interface fr.cnes.sirius.patrius.math.distribution.IntegerDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.LogNormalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.NormalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.PascalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.PoissonDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in interface fr.cnes.sirius.patrius.math.distribution.RealDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.TDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.TriangularDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformIntegerDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformRealDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.distribution.ZipfDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumGenerations() - Method in class fr.cnes.sirius.patrius.math.genetics.FixedGenerationCount
-
Returns the number of generations that have already passed.
- getNutationCoefficients() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.ITerrestrialTidesDataProvider
-
Get constant coefficients coming from the luni solar nutation theory in order to compute the fundamental
arguments.
- getNutationCoefficients() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.TerrestrialTidesDataProvider
-
Get constant coefficients coming from the luni solar nutation theory in order to compute the fundamental
arguments.
- getNutationCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Get the correction to the nutation parameters.
- getNutationCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
-
Get the correction to the nutation parameters.
- getNutationCorrection(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistory
-
Get the correction to the nutation parameters.
- getNutationCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NoEOP2000History
-
Get the correction to the nutation parameters.
- getObjectiveFunction() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.ObjectiveFunction
-
Gets the function to be optimized.
- getObjectiveFunction() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.UnivariateObjectiveFunction
-
Gets the function to be optimized.
- getObjectiveFunctionGradient() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.ObjectiveFunctionGradient
-
Gets the gradient of the function to be optimized.
- getObliquityCoefs() - Method in enum fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecessionConvention
-
Returns the obliquity coefficients.
- getObliquityDegree() - Method in class fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecession
-
Returns the obliquity polynomial development degree.
- getObservations() - Method in class fr.cnes.sirius.patrius.math.fitting.CurveFitter
-
Get the observed points.
- getOcculted() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Get the occulted body.
- getOccultedDirection() - Method in class fr.cnes.sirius.patrius.events.detectors.EclipseDetector
-
Returns the occulted body direction.
- getOccultedRadius() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Get the occulted body radius (m).
- getOcculting() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Get the occulting body.
- getOccultingBodies() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Getter for the occulting bodies.
- getOccultingBodyShape() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Get the occulting body shape
- getOccultingRadiusProvider() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Returns the occulting radius provider.
- getOccurence() - Method in class fr.cnes.sirius.patrius.events.detectors.NthOccurrenceDetector
-
Get the occurrence to detect.
- getOceanTides() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getOceanTidesData() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTides
-
- getOffset(Vector<Euclidean1D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.OrientedPoint
-
Get the offset (oriented distance) of a point.
- getOffset(Plane) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Get the offset (oriented distance) of a parallel plane.
- getOffset(Vector<Euclidean3D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Get the offset (oriented distance) of a point.
- getOffset(Line) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Get the offset (oriented distance) of a parallel line.
- getOffset(Vector<Euclidean2D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Get the offset (oriented distance) of a point.
- getOffset(Vector<S>) - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Hyperplane
-
Get the offset (oriented distance) of a point.
- getOffset() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Returns the offset attribute.
- getOmega() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the mean longitude of the ascending node of the Moon.
- getOmegaInit() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getOmegaInverse() - Method in class fr.cnes.sirius.patrius.math.stat.regression.GLSMultipleLinearRegression
-
Get the inverse of the covariance.
- getOmegaRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getOne() - Method in class fr.cnes.sirius.patrius.math.complex.ComplexField
-
Get the multiplicative identity of the field.
- getOne() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Get the constant 1.
- getOne() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant 1.
- getOne() - Method in interface fr.cnes.sirius.patrius.math.Field
-
Get the multiplicative identity of the field.
- getOne() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFractionField
-
Get the multiplicative identity of the field.
- getOne() - Method in class fr.cnes.sirius.patrius.math.fraction.FractionField
-
Get the multiplicative identity of the field.
- getOne() - Method in class fr.cnes.sirius.patrius.math.util.BigRealField
-
Get the multiplicative identity of the field.
- getOne() - Method in class fr.cnes.sirius.patrius.math.util.Decimal64Field
-
Get the multiplicative identity of the field.
- getOneHarmonicValue(double, double, int) - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DParameterModel
-
Get the value of the nth trigonometric contribution.
- getOpposite() - Method in enum fr.cnes.sirius.patrius.math.interval.IntervalEndpointType
-
Returns OPEN if the instance is CLOSED and CLOSED if the instance is OPEN.
- getOptima() - Method in class fr.cnes.sirius.patrius.math.optim.BaseMultiStartMultivariateOptimizer
-
Gets all the optima found during the last call to optimize.
- getOptima() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
-
Gets all the optima found during the last call to optimize.
- getOptima() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.MultiStartMultivariateVectorOptimizer
-
Gets all the optima found during the last call to optimize.
- getOptima() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.MultiStartUnivariateOptimizer
-
Gets all the optima found during the last call to optimize.
- getOptimizationRequest() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the optimization request
- getOptimizationResponse() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.JOptimizer
-
Get the optimization request
- getOptimizationResponse() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the optimization response
- getOrbit(int) - Method in class fr.cnes.sirius.patrius.covariance.MultiOrbitalCovariance
-
Gets a specific orbit from the list of associated orbits.
- getOrbit() - Method in class fr.cnes.sirius.patrius.covariance.OrbitalCovariance
-
Gets the orbit associated with the covariance.
- getOrbit() - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
- getOrbit() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Gets the current orbit.
- getOrbit() - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
-
Returns the orbit.
- getOrbitalCovariance(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.covariance.BasicOrbitalCovarianceProvider
-
- getOrbitalCovariance(int) - Method in class fr.cnes.sirius.patrius.covariance.MultiOrbitalCovariance
-
Extracts the orbital covariance of the selected orbit.
- getOrbitalCovariance(int, boolean) - Method in class fr.cnes.sirius.patrius.covariance.MultiOrbitalCovariance
-
Extracts the orbital covariance of the selected orbit.
- getOrbitalCovariance(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.covariance.OrbitalCovarianceProvider
-
- getOrbitalCovarianceProvider(int) - Method in class fr.cnes.sirius.patrius.covariance.BasicMultiOrbitalCovarianceProvider
-
Getter for an orbital covariance provider extracting information from this multi orbital covariance.
- getOrbitalCovarianceProvider(int) - Method in interface fr.cnes.sirius.patrius.covariance.MultiOrbitalCovarianceProvider
-
Getter for an orbital covariance provider extracting information from this multi orbital covariance.
- getOrbitNatureConverter() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Get the mean/osculating orbit converter.
- getOrbits() - Method in class fr.cnes.sirius.patrius.covariance.MultiOrbitalCovariance
-
Gets the list of associated orbits.
- getOrbitType() - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Gets the orbit type of covariance.
- getOrbitType() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
- getOrbitType() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialCoordinate
-
Gets the orbit type to which this orbital coordinate is related.
- getOrbitType() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeCoordinate
-
Gets the orbit type to which this orbital coordinate is related.
- getOrbitType() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusCoordinate
-
Gets the orbit type to which this orbital coordinate is related.
- getOrbitType() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianCoordinate
-
Gets the orbit type to which this orbital coordinate is related.
- getOrbitType() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularCoordinate
-
Gets the orbit type to which this orbital coordinate is related.
- getOrbitType() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialCoordinate
-
Gets the orbit type to which this orbital coordinate is related.
- getOrbitType() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialCoordinate
-
Gets the orbit type to which this orbital coordinate is related.
- getOrbitType() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianCoordinate
-
Gets the orbit type to which this orbital coordinate is related.
- getOrbitType() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.OrbitalCoordinate
-
Gets the orbit type to which this orbital coordinate is related.
- getOrbitType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Returns the propagator orbit type.
- getOrbitType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Getter for the orbit type.
- getOrbitType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get propagation parameter type.
- getOrbitType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiPartialDerivativesEquations
-
Returns the propagator orbit type.
- getOrbitType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get propagation parameter type.
- getOrbitType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.PartialDerivativesEquations
-
Returns the propagator orbit type.
- getOrder() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
-
- getOrder() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
- getOrder() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Get the derivation order.
- getOrder() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Get the derivation order.
- getOrder() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for polynomial order.
- getOrder() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierDecompositionEngine
-
- getOrder() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
- getOrder() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.cowell.CowellIntegrator
-
Returns integrator order.
- getOrder() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.DormandPrince54Integrator
-
Get the order of the method.
- getOrder() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.DormandPrince853Integrator
-
Get the order of the method.
- getOrder() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the order of the method.
- getOrder() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.HighamHall54Integrator
-
Get the order of the method.
- getOrderOfRegressors() - Method in class fr.cnes.sirius.patrius.math.stat.regression.MillerUpdatingRegression
-
Gets the order of the regressors, useful if some type of reordering
has been called.
- getOrdinateGrid() - Method in class fr.cnes.sirius.patrius.models.earth.InterpolationTableLoader
-
Returns a copy of the ordinate grid for the interpolation function.
- getOrientation() - Method in class fr.cnes.sirius.patrius.attitudes.Attitude
-
Get the complete orientation including spin and spin derivatives.
- getOrientation(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.DirectionTrackingOrientation
-
Gets the rotation defining the orientation with respect to a given frame at a given date.
- getOrientation(AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.attitudes.IOrientationLaw
-
Gets the rotation defining the orientation with respect to a given frame at a given date.
- getOrientation(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.kinematics.AbstractOrientationFunction
-
Get the orientation at a given date.
- getOrientation(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.attitudes.kinematics.OrientationFunction
-
Get the orientation at a given date.
- getOrientation(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAngularVelocitiesAttitudeProfile
-
Gets the orientation from the angular velocity function at a given date, integrating the function.
- getOrientation(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialSegment
-
Get the orientation from the quaternion polynomials at a given date.
- getOrientation(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialSegment
-
Get the orientation from the quaternion polynomials at a given date.
- getOrientation() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Getter for the celestial body orientation and primer meridians orientation.
- getOrientation() - Method in class fr.cnes.sirius.patrius.bodies.AbstractIAUCelestialBody
-
Getter for the celestial body orientation and primer meridians orientation.
- getOrientation() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Getter for the celestial body orientation and primer meridians orientation.
- getOrientation(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Getter for the celestial body orientation at the specified date in the tabulated attitude leg's reference frame.
- getOrientation(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Getter for the celestial body orientation at the specified date.
- getOrientation() - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Getter for the celestial body IAU orientation and primer meridians orientation.
- getOrientation() - Method in interface fr.cnes.sirius.patrius.bodies.IAUCelestialBody
-
Getter for the celestial body IAU orientation and primer meridians orientation.
- getOrientation() - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the oriented angle between the local north and the x axis (trigowise).
- getOrientationAngle(PVCoordinatesProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.ConstantOrientationAngleLaw
-
Compute the orientation angle corresponding to an orbital state.
- getOrientationAngle(PVCoordinatesProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.ConstantOrientationAngleLeg
-
Compute the orientation angle corresponding to an orbital state.
- getOrientationAngle(PVCoordinatesProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLawLeg
-
Compute the orientation angle corresponding to an orbital state.
- getOrientationAngle(PVCoordinatesProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLegsSequence
-
Compute the orientation angle corresponding to an orbital state.
- getOrientationAngle(PVCoordinatesProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfileSequence
-
Compute the orientation angle corresponding to an orbital state.
- getOrientationAngle(PVCoordinatesProvider, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProvider
-
Compute the orientation angle corresponding to an orbital state.
- getOrientationAngleProvider() - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleTransform
-
The orientation angle provider which provides an angle through time.
- getOrientedAngleBetween2Vector2D(Vector2D, Vector2D) - Static method in class fr.cnes.sirius.patrius.math.interval.AngleTools
-
Computes the oriented angle between 2 vectors 2D.
- getOrientedAngleBewteen2Vector3D(Vector3D, Vector3D, Vector3D) - Static method in class fr.cnes.sirius.patrius.math.interval.AngleTools
-
Computes the oriented angle between 2 vectors 3D.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.libration.IERS2010LibrationCorrection
-
Get IERS model origin.
- getOrigin() - Method in interface fr.cnes.sirius.patrius.frames.configuration.libration.LibrationCorrectionModel
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.libration.LibrationCorrectionPerThread
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.libration.NoLibrationCorrection
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.IERS20032010PrecessionNutation
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.NoPrecessionNutation
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationCache
-
Deprecated.
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationInterpolation
-
Get IERS model origin.
- getOrigin() - Method in interface fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationModel
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutationPerThread
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.StelaPrecessionNutationModel
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.sp.IERS2003SPCorrection
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.sp.IERS2010SPCorrection
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.sp.NoSpCorrection
-
Get IERS model origin.
- getOrigin() - Method in interface fr.cnes.sirius.patrius.frames.configuration.sp.SPrimeModel
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.IERS2003TidalCorrection
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.IERS2010TidalCorrection
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.NoTidalCorrection
-
Get IERS model origin.
- getOrigin() - Method in interface fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrectionModel
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrectionPerThread
-
Get IERS model origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.fitting.LinearRegression
-
Get the origin A of the linear model y = A + B*x
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCone
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCylinder
-
- getOrigin() - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteCone
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This method returns the origin of the cone
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
This method returns the position of the cylinder on the Oxy plane
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCone
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCylinder
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCone
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCylinder
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Line
-
Get the line point closest to the origin.
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.LineSegment
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Get the origin point of the plane frame.
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RectangleCone
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCone
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Screw
-
- getOrigin() - Method in class fr.cnes.sirius.patrius.wrenches.Wrench
-
- getOriginalMeq() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the original number of variables
- getOriginalN() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the original number of variables
- getOriginalN() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the original number of variables
- getOriginOffset() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Get the offset of the origin.
- getOtherDate(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
- getOtherElement() - Method in class fr.cnes.sirius.patrius.events.detectors.LinkTypeHandler
-
Getter for the other element involved in the signal propagation.
- getOutline(PolyhedronsSet) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.OutlineExtractor
-
Extract the outline of a polyhedrons set.
- getOutputPower() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
-
- getOverPerpendicularSteepFacets() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Find all facets from the mesh that break the convexity property of the facet body shape: the
slope angle is over PI/2.
- getP() - Method in class fr.cnes.sirius.patrius.math.linear.FieldLUDecomposition
-
Returns the P rows permutation matrix.
- getP() - Method in class fr.cnes.sirius.patrius.math.linear.LUDecomposition
-
Returns the P rows permutation matrix.
- getP() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for p coefficient.
- getPa() - Method in class fr.cnes.sirius.patrius.data.BodiesElements
-
Get the general accumulated precession in longitude.
- getParamDim() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Returns the parameters dimension.
- getParameter(String) - Method in interface fr.cnes.sirius.patrius.math.ode.ParameterizedODE
-
Get parameter value from its name.
- getParameter() - Method in class fr.cnes.sirius.patrius.math.parameter.ConstantFunction
-
Getter for the parameter associated to this constant function.
- getParameter() - Method in class fr.cnes.sirius.patrius.propagation.numerical.ParameterConfiguration
-
Get parameter.
- getParameterDescriptor(int) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the parameter descriptors associated with the specified row/column of the covariance
matrix.
- getParameterDescriptors() - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Gets the parameter descriptors associated with the covariance matrix.
- getParameterDescriptors() - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the parameter descriptors associated with the rows/columns of the covariance matrix.
- getParameterEstimate(int) - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
Returns the parameter estimate for the regressor at the given index.
- getParameterEstimates() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
Returns a copy of the regression parameters estimates.
- getParameterModels() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Get the array of parameter models.
- getParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AbstractAeroCoeff1D
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAoAAndMach
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffConstant
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.cook.CnCookModel
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.cook.CtCookModel
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Getter for the solar and magnetic activity data.
- getParameters() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
Getter for the solar parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.ZernikePolynomial
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.math.parameter.ConstantFunction
-
Return the function parameter [a0] stored in a list.
- getParameters() - Method in interface fr.cnes.sirius.patrius.math.parameter.IParameterizable
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.math.parameter.LinearCombinationFunction
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.math.parameter.LinearFunction
-
Return the function parameters in this following order: [a0, a1].
- getParameters() - Method in class fr.cnes.sirius.patrius.math.parameter.NthOrderPolynomialFunction
-
Return the function N parameters in this following order : a0, a1, a2,
...
- getParameters() - Method in class fr.cnes.sirius.patrius.math.parameter.Parameterizable
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get underlying orbital parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get underlying orbital parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get underlying orbital parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get underlying orbital parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get underlying orbital parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get underlying orbital parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get underlying orbital parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get underlying orbital parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the number of parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.signalpropagation.ionosphere.BentModel
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AzoulayModel
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.FixedDelayModel
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.MariniMurrayModel
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.SaastamoinenModel
-
Get the supported parameters.
- getParameters() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get underlying orbital parameters.
- getParametersJacobian(SpacecraftState, double[][]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to parameters.
- getParametersJacobian(SpacecraftState, double[][], OrbitType, PositionAngle, Frame) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to parameters.
- getParametersJacobian(SpacecraftState) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to parameters.
- getParametersJacobian(SpacecraftState, OrbitType, PositionAngle, Frame) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to parameters.
- getParametersJacobian(Parameter, SpacecraftState, double[]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to provided parameter parameter.
- getParametersJacobian(Parameter, SpacecraftState, double[], OrbitType, PositionAngle, Frame) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to provided parameter parameter.
- getParametersJacobian(Parameter, SpacecraftState) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to provided parameter parameter.
- getParametersJacobian(Parameter, SpacecraftState, OrbitType, PositionAngle, Frame) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to provided parameter parameter.
- getParametersList() - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get parameters list.
- getParametersNames() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractParameterizable
-
Get the names of the supported parameters.
- getParametersNames() - Method in interface fr.cnes.sirius.patrius.math.ode.Parameterizable
-
Get the names of the supported parameters.
- getParent() - Method in class fr.cnes.sirius.patrius.assembly.AbstractPart
- getParent() - Method in interface fr.cnes.sirius.patrius.assembly.IPart
-
- getParent() - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the parent frame.
- getParent() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BSPTree
-
Get the parent node.
- getPart(String) - Method in class fr.cnes.sirius.patrius.assembly.Assembly
-
Returns the part whose name is specified.
- getPart(String) - Method in class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
-
This method returns the part whose name is given in parameter.
- getPartialCorrelations(int) - Method in class fr.cnes.sirius.patrius.math.stat.regression.MillerUpdatingRegression
-
In the original algorithm only the partial correlations of the regressors
is returned to the user.
- getPartialDerivative(int...) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Get a partial derivative.
- getPartialDerivativeIndex(int...) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Get the index of a partial derivative in the array.
- getPartialDerivativeOrders(int) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Get the derivation orders for a specific index in the array.
- getPartLevel() - Method in class fr.cnes.sirius.patrius.assembly.AbstractPart
- getPartLevel() - Method in interface fr.cnes.sirius.patrius.assembly.IPart
-
- getPartName() - Method in class fr.cnes.sirius.patrius.assembly.properties.PropulsiveProperty
-
Getter for the part name owning the property.
- getPartName() - Method in class fr.cnes.sirius.patrius.assembly.properties.TankProperty
-
Getter for the part name owning the property.
- getPartName() - Method in class fr.cnes.sirius.patrius.events.detectors.NullMassPartDetector
-
Get the name of the part (attribute).
- getParts() - Method in class fr.cnes.sirius.patrius.assembly.Assembly
-
Returns all the parts of the assembly.
- getParts() - Method in exception fr.cnes.sirius.patrius.utils.exception.PatriusException
-
Get the variable parts of the error message.
- getPastCycleFilePath() - Static method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCycleSolarActivityProperties
-
Get the past cycles file paths
Warning : InputStreams can only be read once
- getPatriusCompatibilityMode() - Static method in class fr.cnes.sirius.patrius.utils.PatriusConfiguration
-
- getPct(Comparable<?>) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPct(int) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPct(long) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPct(char) - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPercentile(double) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns an estimate for the pth percentile of the stored values.
- getPercentileImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured percentile implementation.
- getPeriapsis() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the periapsis.
- getPeriapsis() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Get the periapsis.
- getPeriapsisAltitude() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Get the periapsis altitude.
- getPerigeeArgument() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the perigee argument.
- getPerigeeArgument() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the perigee argument.
- getPerigeeArgument() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Get the perigee argument.
- getPerigeeArgument() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Get the perigee argument.
- getPerigeeArgument() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Get the perigee argument.
- getPerigeeArgument() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the argument of perigee in [0, 2π].
- getPeriod() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierDecompositionEngine
-
- getPeriod() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
- getPeriod() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeriesApproximation
-
- getPeriodicComputationMethod() - Static method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Getter for periodicComputationMethod
- getPh() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.HelmholtzPolynomial
-
Get the Hlm coefficients
- getPhasingAxis() - Method in class fr.cnes.sirius.patrius.attitudes.YawSteering
-
Getter for the satellite axis that must be roughly in Sun direction.
- getPhenomena(String, String, AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.events.postprocessing.PhenomenaList
-
Finds one/more events in the list of
Phenomenon following some criteria.
- getPhenomena() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
-
- getPhenomenaCodes() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
-
- getPhenomenaCodesList() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
-
- getPhenomenaList() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
-
- getPhenomenonCode() - Method in interface fr.cnes.sirius.patrius.events.postprocessing.CodingEventDetector
-
If the implementation supports a
Phenomenon, provides a code for
the phenomenon associated to the event.
- getPhenomenonCode() - Method in class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
If the implementation supports a
Phenomenon, provides a code for
the phenomenon associated to the event.
- getPhenomenonCode() - Method in interface fr.cnes.sirius.patrius.events.postprocessing.MultiCodingEventDetector
-
If the implementation supports a
Phenomenon, provides a code for
the phenomenon associated to the event.
- getPhenomenonCode() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiGenericCodingEventDetector
-
If the implementation supports a
Phenomenon, provides a code for
the phenomenon associated to the event.
- getPhi() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGridPoint
-
Gets the azimuth angle between 0° (included) and 360° (excluded).
- getPi() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant π.
- getPiSplit() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant π split in two pieces.
- getPivot() - Method in class fr.cnes.sirius.patrius.math.linear.FieldLUDecomposition
-
Returns the pivot permutation vector.
- getPivot() - Method in class fr.cnes.sirius.patrius.math.linear.LUDecomposition
-
Returns the pivot permutation vector.
- getPivotPoint() - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
-
Getter for the projection pivot point.
- getPlus() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BSPTree
-
Get the tree on the plus side of the cut hyperplane.
- getPlus() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Get the part of the sub-hyperplane on the plus side of the splitting hyperplane.
- getPlusInside() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BoundaryAttribute
-
Get the part of the node cut sub-hyperplane that belongs to the
boundary and has the inside of the region on the plus side of
its underlying hyperplane.
- getPlusOutside() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BoundaryAttribute
-
Get the part of the node cut sub-hyperplane that belongs to the
boundary and has the outside of the region on the plus side of
its underlying hyperplane.
- getPluto() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Pluto singleton body.
- getPoint(String) - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get a celestial point.
- getPoint() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Intersection
-
Returns the intersection point in input frame.
- getPoint() - Method in class fr.cnes.sirius.patrius.events.detectors.PlaneCrossingDetector
-
Getter for the point belonging to the plane used for plane definition.
- getPoint(int) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Get the simplex point stored at the requested index.
- getPoint() - Method in class fr.cnes.sirius.patrius.math.optim.PointValuePair
-
Getter for the point.
- getPoint() - Method in class fr.cnes.sirius.patrius.math.optim.PointVectorValuePair
-
Gets the point.
- getPoint() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.UnivariatePointValuePair
-
Get the point.
- getPoint() - Method in class fr.cnes.sirius.patrius.math.stat.clustering.EuclideanDoublePoint
-
Get the n-dimensional point in integer space.
- getPoint() - Method in class fr.cnes.sirius.patrius.math.stat.clustering.EuclideanIntegerPoint
-
Get the n-dimensional point in integer space.
- getPoint() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AbstractMeteoBasedCorrectionFactory.MeteoBasedKey
-
Getter for the point.
- getPoint() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Getter for the position where the model should be applied.
- getPointAt(Vector2D, double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Get one point from the 3D-space.
- getPointAt(Vector1D, double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Get one point from the plane.
- getPointingLoss(double) - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
-
Gets the pointing loss using a spline interpolation.
- getPointRef() - Method in class fr.cnes.sirius.patrius.math.optim.PointValuePair
-
Getter for the reference to the point.
- getPointRef() - Method in class fr.cnes.sirius.patrius.math.optim.PointVectorValuePair
-
Getter for a reference to the point.
- getPoints() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGrid
-
Gets the list of grid points.
- getPoints() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Get the points of the simplex.
- getPoints() - Method in class fr.cnes.sirius.patrius.math.stat.clustering.Cluster
-
Get the points contained in the cluster.
- getPolarMotion(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Compute corrected polar motion.
- getPolarMotion(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Compute corrected polar motion.
- getPolarMotionModel() - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Get the polar motion model.
- getPolarMotionModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Get the polar motion model.
- getPolarRadius() - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
Getter for the polar radius of the body.
- getPolarRadius() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Spheroid
-
Get polar radius of Spheroid.
- getPole(AbsoluteDate, IAUPoleModelType) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyIAUOrientation
-
Getter for the body North pole direction with respect to a reference frame.
- getPole(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyOrientation
-
Getter for the body North pole direction with respect to a reference frame.
- getPole(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Getter for the body North pole direction with respect to a reference frame.
- getPole(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the body North pole direction with respect to a reference frame.
- getPole(AbsoluteDate, IAUPoleModelType) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the body North pole direction with respect to a reference frame.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Get the pole IERS Reference Pole correction.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
-
Get the pole IERS Reference Pole correction.
- getPoleCorrection(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistory
-
Get the pole IERS Reference Pole correction.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NoEOP2000History
-
Get the pole IERS Reference Pole correction.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.libration.IERS2010LibrationCorrection
-
This method provides the diurnal lunisolar effect on polar motion in time domain.
- getPoleCorrection(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.libration.LibrationCorrectionModel
-
Compute the pole corrections at a given date.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.libration.LibrationCorrectionPerThread
-
Compute the pole corrections at a given date.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.libration.NoLibrationCorrection
-
Compute the pole corrections at a given date.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.PolarMotion
-
Compute pole correction.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.IERS2003TidalCorrection
-
Compute the pole corrections at a given date.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.IERS2010TidalCorrection
-
Compute the pole corrections at a given date.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.NoTidalCorrection
-
Compute the pole corrections at a given date.
- getPoleCorrection() - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrection
-
- getPoleCorrection(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrectionModel
-
Compute the pole corrections at a given date.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrectionPerThread
-
Compute the pole corrections at a given date.
- getPoleCorrection(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.TODProvider
-
Get the pole IERS Reference Pole correction.
- getPoleDerivative(AbsoluteDate, IAUPoleModelType) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyIAUOrientation
-
Getter for the body North pole direction derivative with respect to a reference frame.
- getPoleDerivative(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyOrientation
-
Getter for the body North pole direction derivative with respect to a reference frame.
- getPoleDerivative(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Getter for the body North pole direction derivative with respect to a reference frame.
- getPoleDerivative(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the body North pole direction derivative with respect to a reference frame.
- getPoleDerivative(AbsoluteDate, IAUPoleModelType) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the body North pole direction derivative with respect to a reference frame.
- getPolynomialObliquity() - Method in class fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecession
-
Returns the Obliquity polynomial.
- getPolynomialOrder() - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
- getPolynomialPrecessionTheta() - Method in class fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecession
-
Returns the Precession (Theta) polynomial.
- getPolynomialPrecessionZ() - Method in class fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecession
-
Returns the Precession (Z) polynomial.
- getPolynomialPrecessionZeta() - Method in class fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecession
-
Returns the Precession (Zeta) polynomial.
- getPolynomials() - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.HermiteInterpolator
-
Compute the interpolation polynomials.
- getPolynomials() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialSplineFunction
-
Get a copy of the interpolating polynomials array.
- getPolynomialType() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the type of this polynomial function.
- getPolynomialType() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunction
-
Getter for the type of this polynomial function.
- getPolynomialType() - Method in interface fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunctionInterface
-
Getter for the type of this polynomial function.
- getPolynomialType() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialChebyshevFunction
-
Return the type of this polynomial function.
- getPolynomialType() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunction
-
Return the type of this polynomial function.
- getPolynomialType() - Method in interface fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunctionInterface
-
Return the type of this polynomial function.
- getPolyOrder(double, double, double, double, double) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Determination of the order of A4*s4 + A3*s3 +
A2*s2 + A1*s1 + A0 .
- getPomega() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the longitude of the periapsis (ω + Ω).
- getPomega() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Get the longitude of the periapsis (ω + Ω).
- getPopulationLimit() - Method in class fr.cnes.sirius.patrius.math.genetics.ListPopulation
-
Access the maximum population size.
- getPopulationLimit() - Method in interface fr.cnes.sirius.patrius.math.genetics.Population
-
Access the maximum population size.
- getPopulationSize() - Method in class fr.cnes.sirius.patrius.math.distribution.HypergeometricDistribution
-
Access the population size.
- getPopulationSize() - Method in class fr.cnes.sirius.patrius.math.genetics.ListPopulation
-
Access the current population size.
- getPopulationSize() - Method in interface fr.cnes.sirius.patrius.math.genetics.Population
-
Access the current population size.
- getPopulationSize() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.CMAESOptimizer.PopulationSize
-
- getPopulationVariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
- getPopulationVariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
- getPopulationVariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
- getPosition() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Get the point cartesian position expressed in body frame.
- getPosition() - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Get the point cartesian position expressed in body frame.
- getPosition() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Vertex
-
Returns the vertex 3D position.
- getPosition() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionDataPoint
-
Returns the position.
- getPosition() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Get the position.
- getPosition() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPosition
-
Gets the position.
- getPosition() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Gets the position.
- getPosition() - Method in interface fr.cnes.sirius.patrius.orbits.pvcoordinates.Position
-
Gets the position.
- getPosition() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.PVCoordinates
-
Gets the position.
- getPosition() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPosition
-
Gets the position.
- getPosition() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPV
-
Gets the position.
- getPosition() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaDragCoefInput
-
Getter for the position.
- getPositionAngle() - Method in class fr.cnes.sirius.patrius.covariance.AbstractOrbitalCovariance
-
Gets the position angle type of the covariance.
- getPositionAngle() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Returns the propagator position angle.
- getPositionAngle() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiPartialDerivativesEquations
-
Returns the propagator position angle.
- getPositionAngle() - Method in class fr.cnes.sirius.patrius.propagation.numerical.PartialDerivativesEquations
-
Returns the propagator position angle.
- getPositionAngleType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get propagation parameter type.
- getPositionAngleType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Get propagation parameter type.
- getPositionTolerance() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.AbstractTLEFitter
-
Get the desired position tolerance.
- getPositionVelocity(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.PosVelChebyshev
-
Get the position-velocity-acceleration at a specified date.
- getPositivePolarForm() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Returns the polar form of the quaternion.
- getPotential() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionDataPoint
-
Returns the potential.
- getPotentialArray() - Method in interface fr.cnes.sirius.patrius.forces.gravity.grid.GridSystem
-
Returns potential data array (values along ordinates).
- getPotentialProvider() - Static method in class fr.cnes.sirius.patrius.forces.gravity.potential.GravityFieldFactory
-
Get the gravity field coefficients provider from the first supported file.
- getPrecessionDegree() - Method in class fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecession
-
Returns the obliquity polynomial development degree.
- getPrecessionNutationModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.PrecessionNutation
-
- getPrecessionThetaCoefs() - Method in enum fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecessionConvention
-
Returns the precession coefficients (theta).
- getPrecessionZCoefs() - Method in enum fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecessionConvention
-
Returns the precession coefficients (Z).
- getPrecessionZetaCoefs() - Method in enum fr.cnes.sirius.patrius.frames.configuration.modprecession.IAUMODPrecessionConvention
-
Returns the precession coefficients (zeta).
- getPreciseSecondsInDay() - Method in class fr.cnes.sirius.patrius.time.TimeComponents
-
Get the precise second number within the day.
- getPrefix() - Method in class fr.cnes.sirius.patrius.math.geometry.VectorFormat
-
Get the format prefix.
- getPrefix() - Method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Get the format prefix.
- getPrefix() - Method in class fr.cnes.sirius.patrius.math.linear.RealVectorFormat
-
Get the format prefix.
- getPresolvedA() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved matrix A
- getPresolvedB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved vector B
- getPresolvedC() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved vector C
- getPresolvedLB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved lower bounds vector
- getPresolvedMeq() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved number of variables
- getPresolvedN() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved number of variables
- getPresolvedUB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved upper bounds vector
- getPresolvedYlb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved Y lower bounds vector
- getPresolvedYub() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved Y upper bounds vector
- getPresolvedZlb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved Z lower bounds vector
- getPresolvedZub() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Get the presolved Z upper bounds vector
- getPress(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.US76
-
Getter for the local pressure for altitude in interval [0, 1E6]m.
- getPressure() - Method in class fr.cnes.sirius.patrius.events.detectors.ApparentElevationDetector
-
Get the local pressure at topocentric frame origin.
- getPressure(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
Getter for the pressure.
- getPressure() - Method in class fr.cnes.sirius.patrius.signalpropagation.MeteorologicalConditions
-
Getter for the pressure [Pa].
- getPrevious() - Method in exception fr.cnes.sirius.patrius.math.exception.NonMonotonicSequenceException
-
- getPrevious() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.AVLTree.Node
-
Get the node containing the next smaller or equal element.
- getPreviousAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeEphemerisGenerator
-
Returns attitude from previous leg (compared to leg matching provided date) from the
sequence.
- getPreviousDate() - Method in class fr.cnes.sirius.patrius.propagation.sampling.AdaptedStepHandler
-
Get the previous grid date.
- getPreviousDate() - Method in class fr.cnes.sirius.patrius.propagation.sampling.BasicStepInterpolator
-
Get the previous grid date.
- getPreviousDate() - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
-
Get the previous grid date.
- getPreviousDate() - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiPatriusStepInterpolator
-
Get the previous grid date.
- getPreviousDate() - Method in interface fr.cnes.sirius.patrius.propagation.sampling.PatriusStepInterpolator
-
Get the previous grid date.
- getPreviousDate() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
-
Get the previous grid date.
- getPreviousDescriptor() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the previous descriptor returned.
- getPreviousEventTime() - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Get previous event time.
- getPreviousHandle() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the previous handle returned.
- getPreviousIndex() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractBoundedPVProvider
-
Getter for the previous search index.
- getPreviousSegmentId() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the previous segment identifier returned.
- getPreviousState() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.cowell.CowellIntegrator
-
Returns integrator previous state.
- getPreviousTime() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Get the previous soft grid point time.
- getPreviousTime() - Method in interface fr.cnes.sirius.patrius.math.ode.sampling.StepInterpolator
-
Get the previous grid point time.
- getPrimary() - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get the primary set of differential equations.
- getPrimaryMapper() - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get an equations mapper for the primary equations set.
- getPrimaryState() - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get primary part of the current state.
- getPrimaryStateDot() - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get primary part of the current state derivative.
- getPrimeMeridianAngle(AbsoluteDate, IAUPoleModelType) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyIAUOrientation
-
Getter for the prime meridian angle.
- getPrimeMeridianAngle(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyOrientation
-
Getter for the prime meridian angle.
- getPrimeMeridianAngle(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Getter for the prime meridian angle.
- getPrimeMeridianAngle(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the prime meridian angle.
- getPrimeMeridianAngle(AbsoluteDate, IAUPoleModelType) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the prime meridian angle.
- getPrimeMeridianAngleDerivative(AbsoluteDate, IAUPoleModelType) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyIAUOrientation
-
Getter for the prime meridian angle derivative.
- getPrimeMeridianAngleDerivative(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBodyOrientation
-
Getter for the prime meridian angle derivative.
- getPrimeMeridianAngleDerivative(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Getter for the prime meridian angle derivative.
- getPrimeMeridianAngleDerivative(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the prime meridian angle derivative.
- getPrimeMeridianAngleDerivative(AbsoluteDate, IAUPoleModelType) - Method in class fr.cnes.sirius.patrius.bodies.UserIAUPole
-
Getter for the prime meridian angle derivative.
- getPrintFunction() - Method in class fr.cnes.sirius.patrius.math.parameter.FieldDescriptor
-
Gets the function to use when converting field values to strings.
- getProbabilityOfSuccess() - Method in class fr.cnes.sirius.patrius.math.distribution.BinomialDistribution
-
Access the probability of success for this distribution.
- getProbabilityOfSuccess() - Method in class fr.cnes.sirius.patrius.math.distribution.PascalDistribution
-
Access the probability of success for this distribution.
- getProcessNoise() - Method in class fr.cnes.sirius.patrius.math.filter.DefaultProcessModel
-
Returns the process noise matrix.
- getProcessNoise() - Method in interface fr.cnes.sirius.patrius.math.filter.ProcessModel
-
Returns the process noise matrix.
- getPropagationDelayType() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Getter for the propagation delay type.
- getPropagationDelayType() - Method in class fr.cnes.sirius.patrius.forces.radiation.LightingRatio
-
Getter for the propagation delay type.
- getPropagationDelayType() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Getter for the propagation delay type.
- getPropagationFrame() - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Getter for the propagation frame.
- getPropagator() - Method in class fr.cnes.sirius.patrius.assembly.models.SecondarySpacecraft
-
- getPropagator() - Method in class fr.cnes.sirius.patrius.propagation.analytical.AdapterPropagator
-
Get the reference propagator.
- getPropagators() - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get spacecraft state providers map.
- getProperInstance() - Static method in class fr.cnes.sirius.patrius.math.fraction.BigFractionFormat
-
Returns the default complex format for the current locale.
- getProperInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.fraction.BigFractionFormat
-
Returns the default complex format for the given locale.
- getProperInstance() - Static method in class fr.cnes.sirius.patrius.math.fraction.FractionFormat
-
Returns the default complex format for the current locale.
- getProperInstance(Locale) - Static method in class fr.cnes.sirius.patrius.math.fraction.FractionFormat
-
Returns the default complex format for the given locale.
- getProperty(PropertyType) - Method in class fr.cnes.sirius.patrius.assembly.AbstractPart
-
Returns a property of the part : if in this part, one exists of the given type.
- getProperty(PropertyType) - Method in interface fr.cnes.sirius.patrius.assembly.IPart
-
Returns a property of the part : if in this part, one exists of the given type.
- getPropulsiveProperty() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the propulsive property.
- getPropulsiveProperty() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get the propulsive property.
- getProvider() - Method in class fr.cnes.sirius.patrius.propagation.numerical.ParameterConfiguration
-
Get the povider handling this parameter.
- getProviders() - Method in class fr.cnes.sirius.patrius.data.DataProvidersManager
-
Get an unmodifiable view of the list of supported providers.
- getPseudoInertialFrame() - Method in class fr.cnes.sirius.patrius.attitudes.LofOffset
-
Getter for the inertial frame with respect to which orbit should be computed.
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.bodies.BSPCelestialBodyLoader.SSBEphemeris
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.bodies.EarthEphemeris
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.covariance.OrbitalCovarianceProvider
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.groundstation.GeometricStationAntenna
-
Get the
PVCoordinates of the station antenna in the selected frame.
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
-
- getPVCoordinates(Frame) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- getPVCoordinates() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- getPVCoordinates() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Get the PV coordinates.
- getPVCoordinates(AbsoluteDate, Frame, Vector3D[], boolean) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractEphemerisPvHermiteLagrange
-
Common method to get PV coordinates using Hermite interpolation, either in a "Lagrange-like" manner, or in a
traditional manner.
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.ConstantPVCoordinatesProvider
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.EphemerisPvHermite
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.EphemerisPvLagrange
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSPVCoordinates
-
Geometric computation of the position to a date.
- getPVCoordinates(AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.orbits.pvcoordinates.PVCoordinatesProvider
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Default implementation for PVCoordinatesProvider feature using the
SpacecraftState
object's orbit.
- getPVCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
Get the extrapolated position and velocity from an initial TLE.
- getPVCoordinates(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLESeries
-
Get the extrapolated position and velocity from an initial date.
- getPVCoordinates(AbsoluteDate, Frame, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Default implementation for PVCoordinatesProvider feature using the
SpacecraftState
object's orbit.
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.Ephemeris
-
Default implementation for PVCoordinatesProvider feature using the
SpacecraftState
object's orbit.
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.IntegratedEphemeris
-
Default implementation for PVCoordinatesProvider feature using the
SpacecraftState
object's orbit.
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
-
Default implementation for PVCoordinatesProvider feature using the
SpacecraftState
object's orbit.
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Default implementation for PVCoordinatesProvider feature using the
SpacecraftState
object's orbit.
- getPVCoordinates() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
- getPVCoordinates(Frame) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.propagation.SpacecraftStateProvider
-
Default implementation for PVCoordinatesProvider feature using the
SpacecraftState
object's orbit.
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
- getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Default implementation for PVCoordinatesProvider feature using the
SpacecraftState
object's orbit.
- getPVCoordinatesProvider() - Method in class fr.cnes.sirius.patrius.events.detectors.AlignmentDetector
-
Get the body to align.
- getPVFunction() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.AbstractTLEFitter
-
Get the function computing position/velocity at sample points.
- getPVPropagation() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the propagation position/velocity vectors in the reference frame.
- getPvProvider() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Get PV coordinates provider.
- getPvProvider() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Get PV coordinates provider.
- getPVTarget() - Method in class fr.cnes.sirius.patrius.events.detectors.CircularFieldOfViewDetector
-
Get the position/velocity provider of the target .
- getPVTarget() - Method in class fr.cnes.sirius.patrius.events.detectors.DihedralFieldOfViewDetector
-
Get the position/velocity provider of the target .
- getQ() - Method in class fr.cnes.sirius.patrius.math.linear.QRDecomposition
-
Returns the matrix Q of the decomposition.
- getQ() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for q coefficient.
- getQ0() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Gets the first component of the quaternion (scalar part).
- getQ0() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldRotation
-
Get the scalar coordinate of the quaternion.
- getQ0Coefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialProfile
-
- getQ0Coefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialSegment
-
- getQ0FourierSeries() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
- getQ0Polynomial() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialSegment
-
Getter for the polynomial function of date representing the q0 quaternion component.
- getQ1() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Gets the second component of the quaternion (first component
of the vector part).
- getQ1() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldRotation
-
Get the first coordinate of the vectorial part of the quaternion.
- getQ1Coefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialProfile
-
- getQ1Coefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialSegment
-
- getQ1FourierSeries() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
- getQ1Polynomial() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialSegment
-
Getter for the polynomial function of date representing the q1 quaternion component.
- getQ2() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Gets the third component of the quaternion (second component
of the vector part).
- getQ2() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldRotation
-
Get the second coordinate of the vectorial part of the quaternion.
- getQ2Coefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialProfile
-
- getQ2Coefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialSegment
-
- getQ2FourierSeries() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
- getQ2Polynomial() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialSegment
-
Getter for the polynomial function of date representing the q2 quaternion component.
- getQ3() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Gets the fourth component of the quaternion (third component
of the vector part).
- getQ3() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldRotation
-
Get the third coordinate of the vectorial part of the quaternion.
- getQ3Coefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialProfile
-
- getQ3Coefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialSegment
-
- getQ3FourierSeries() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
- getQ3Polynomial() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialSegment
-
Getter for the polynomial function of date representing the q3 quaternion component.
- getQi() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Rotation
-
Get the normalized quaternion in double[] type : {q0, q1,
q2, q3}.
- getQT() - Method in class fr.cnes.sirius.patrius.math.linear.QRDecomposition
-
Returns the transpose of the matrix Q of the decomposition.
- getQuad() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for quads as an array.
- getQuadsList() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
-
Getter for the quad list.
- getQuantile() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Percentile
-
Returns the value of the quantile field (determines what percentile is
computed when evaluate() is called with no quantile argument).
- getQuaternion() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Rotation
-
Get the normalized quaternion.
- getR() - Method in class fr.cnes.sirius.patrius.math.linear.QRDecomposition
-
Returns the matrix R of the decomposition.
- getR(boolean) - Method in class fr.cnes.sirius.patrius.math.linear.QRDecomposition
-
Returns the matrix R of the decomposition in its compact form (n × n) or in its full form
(m × n).
- getR() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
- getR12(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.signalpropagation.ionosphere.R12Loader
-
Provides the R12 value for the Bent model.
- getR12(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.signalpropagation.ionosphere.R12Provider
-
Provides the R12 value for the Bent model.
- getRaan() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get Right Ascension of the Ascending node in [0, 2π].
- getRadialProjectionOnShape() - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Returns the body point, on the associated shape surface, in the radial direction corresponding to the position of
this: if several of them (may happen for not star-convex shapes), the method considers the one farthest to the
body frame origin (having the largest norm).
- getRadialProjectionOnShape() - Method in interface fr.cnes.sirius.patrius.bodies.BodyPoint
-
Returns the body point, on the associated shape surface, in the radial direction corresponding to the position of
this: if several of them (may happen for not star-convex shapes), the method considers the one farthest to the
body frame origin (having the largest norm).
- getRadialProjectionOnShape() - Method in class fr.cnes.sirius.patrius.bodies.EllipsoidPoint
-
Returns the body point, on the associated shape surface, in the radial direction corresponding to the position of
this: if several of them (may happen for not star-convex shapes), the method considers the one farthest to the
body frame origin (having the largest norm).
- getRadialProjectionOnShape() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetPoint
-
Returns the body point, on the associated shape surface, in the radial direction corresponding to the position of
this: if several of them (may happen for not star-convex shapes), the method considers the one farthest to the
body frame origin (having the largest norm).
- getRadiativeIRProperty() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.RadiativeProperties
-
Get infrared radiative properties.
- getRadiativeProperties() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Get main shape radiative properties.
- getRadiativePropertiesTab() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Returns the radiative properties : absorption, specular and diffusion coefficient (visible
and IR), as an array : [0] : absorption coefficient (visible) [1] : specular coefficient
(visible) [2] : diffusion coefficient (visible) [3] : absorption coefficient (IR) [4] :
specular coefficient (IR) [5] : diffusion coefficient (IR)
- getRadiativeProperty() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.RadiativeProperties
-
Get radiative properties.
- getRadius() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGridPoint
-
Gets the radius.
- getRadius() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRightCircularCylinder
-
- getRadius() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
- getRadius() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularSurfaceCylinder
-
Get radius corresponding to perpendicular x axis surface (m).
- getRadius() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
- getRadiusA() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractEllipse
-
- getRadiusA() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCylinder
-
- getRadiusB() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractEllipse
-
- getRadiusB() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCylinder
-
- getRadiusFromSurface(double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Get radius from surface value.
- getRadixDigits() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Get the number of radix digits of the instance.
- getRadixDigits() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the number of radix digits of the
Dfp instances built by this factory.
- getRan() - Method in class fr.cnes.sirius.patrius.math.random.RandomDataGenerator
-
Returns the RandomGenerator used to generate non-secure random data.
- getRandomGenerator() - Static method in class fr.cnes.sirius.patrius.math.genetics.GeneticAlgorithm
-
Returns the (static) random generator.
- getRange(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the range of a point with regards to the topocentric frame center point.
- getRange() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the Chebyshev polynomial range.
- getRange() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPosition
-
Get the range.
- getRange() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Get the range.
- getRange() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPosition
-
Get the range.
- getRange() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPV
-
Get the range.
- getRangeRate(PVCoordinates, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the range rate of a point with regards to the topocentric frame center point.
- getRangeRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Get the range rate.
- getRangeRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPV
-
Get the range rate.
- getRank() - Method in class fr.cnes.sirius.patrius.math.linear.RectangularCholeskyDecomposition
-
Get the rank of the symmetric positive semidefinite matrix.
- getRank() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Return the effective numerical matrix rank.
- getRank() - Method in class fr.cnes.sirius.patrius.math.random.CorrelatedRandomVectorGenerator
-
Get the rank of the covariance matrix.
- getRank() - Method in class fr.cnes.sirius.patrius.math.random.UniformlyCorrelatedRandomVectorGenerator
-
Get the rank of the covariance matrix.
- getRankCorrelation() - Method in class fr.cnes.sirius.patrius.math.stat.correlation.SpearmansCorrelation
-
- getRate() - Method in class fr.cnes.sirius.patrius.attitudes.SpinStabilized
-
Getter for the spin rate in radians per seconds.
- getRatio() - Method in class fr.cnes.sirius.patrius.math.genetics.UniformCrossover
-
- getRawProvider() - Method in class fr.cnes.sirius.patrius.frames.transformations.InterpolatingTransformProvider
-
Get the underlying provider for raw (non-interpolated) transforms.
- getReal() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Get the real value of the number.
- getReal() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Access the real part.
- getReal(int) - Method in class fr.cnes.sirius.patrius.math.complex.RootsOfUnity
-
Get the real part of the k-th n-th root of unity.
- getReal() - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Get the real value of the number.
- getRealEigenvalue(int) - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Returns the real part of the ith eigenvalue of the original
matrix.
- getRealEigenvalues() - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Gets a copy of the real parts of the eigenvalues of the original matrix.
- getRealFormat() - Method in class fr.cnes.sirius.patrius.math.complex.ComplexFormat
-
Access the realFormat.
- getRealMatrix() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Matrix3D
-
- getRealVector() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Get a RealVector with identical data.
- getRealVector() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get a RealVector with identical data.
- getRealVector() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Get a RealVector with identical data.
- getRealVector() - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Get a RealVector with identical data.
- getReceiver() - Method in class fr.cnes.sirius.patrius.assembly.models.RFLinkBudgetModel
-
Returns the receiver (ground antenna).
- getReceiver(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Getter for the signal receiver.
- getReceiver(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Getter for the signal receiver.
- getReceiverDatesList() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Getter for the list of the receiver dates of the occurred events.
- getReceiverDatesMap() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Getter for the Map of the receiver (keys) & emitter (values) dates of the occurred events.
- getReceiverPV() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getReceptionDate() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the reception date.
- getRecnoCurrSummary() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Getter for the record containing the current summary record.
- getRecnoNextSummary() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Getter for the record containing the next summary record.
- getRecnoPrevSummary() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Getter for the record containing the previous summary record.
- getRediffusedRadiationPressure() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getReducedFraction(int, int) - Static method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Creates a BigFraction instance with the 2 parts of a fraction Y/Z.
- getReducedFraction(int, int) - Static method in class fr.cnes.sirius.patrius.math.fraction.Fraction
-
Creates a Fraction instance with the 2 parts of a fraction Y/Z.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into reentry parameters.
- getReentryParameters(double, double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into reentry parameters.
- getReference() - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleTransform
-
Returns the reference transform.
- getReference() - Method in class fr.cnes.sirius.patrius.math.interval.AngleInterval
-
- getReference() - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
-
Getter for the system of reference used.
- getReference() - Method in interface fr.cnes.sirius.patrius.projections.IProjection
-
Getter for the system of reference used.
- getReferenceAttitude() - Method in class fr.cnes.sirius.patrius.attitudes.FixedRate
-
Get the reference attitude.
- getReferenceAxis(Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the reference axis of the sensor in a given frame at a date
- getReferenceAxis() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
- getReferenceDate() - Method in class fr.cnes.sirius.patrius.events.detectors.RelativeDateDetector
-
Getter for the reference date of the event.
- getReferenceDate() - Method in class fr.cnes.sirius.patrius.math.fitting.SecularAndHarmonic
-
Get the reference date.
- getReferenceDate() - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Get the reference date.
- getReferenceDate() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Get the reference date
- getReferenceFlux() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Getter for the parameter representing the reference flux normalized for a 1m distance (N).
- getReferenceFrame() - Method in class fr.cnes.sirius.patrius.attitudes.Attitude
-
Get the reference frame.
- getReferenceFrame() - Method in class fr.cnes.sirius.patrius.attitudes.ConstantAttitudeLaw
-
Getter for the reference frame.
- getReferenceFrame() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialProfile
-
Returns the reference frame of the polynomial functions.
- getReferenceFrame() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialProfile
-
Returns the reference frame of the polynomial functions.
- getReferenceFrame() - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Getter for the reference frame.
- getReflectingArea() - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Gets the reflecting area of the object.
- getReflectionCoef() - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Gets the reflection coefficient of the object.
- getRegressionSumSquares() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
Returns the sum of squared deviations of the predicted y values about their mean (which equals the mean of y).
- getRegressionSumSquares() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the predicted y values about
their mean (which equals the mean of y).
- getRelationship() - Method in class fr.cnes.sirius.patrius.math.optim.linear.LinearConstraint
-
Gets the relationship between left and right hand sides.
- getRelativeAccuracy() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the actual relative accuracy.
- getRelativeAccuracy() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.UnivariateIntegrator
-
Get the actual relative accuracy.
- getRelativeAccuracy() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Get the relative accuracy of the solver.
- getRelativeAccuracy() - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BaseUnivariateSolver
-
Get the relative accuracy of the solver.
- getRelativeAccuracy() - Method in class fr.cnes.sirius.patrius.math.dfp.BracketingNthOrderBrentSolverDFP
-
Get the relative accuracy.
- getRelativeCovariance(int, int) - Method in class fr.cnes.sirius.patrius.covariance.MultiOrbitalCovariance
-
Computes the relative covariance between two orbits.
- getRelativeCovarianceMatrix(int, int) - Method in class fr.cnes.sirius.patrius.covariance.MultiOrbitalCovariance
-
Computes the relative covariance matrix between two orbits.
- getRelativeDate() - Method in class fr.cnes.sirius.patrius.events.detectors.RelativeDateDetector
-
Getter for the target relative date in seconds.
- getRelativeThreshold() - Method in class fr.cnes.sirius.patrius.math.optim.AbstractConvergenceChecker
-
- getRelativisticCorrection(double) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSPVCoordinates
-
Compute the relativistic correction term for the satellite time correction
- getRelTol() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquationsAndTolerances
-
Returns relative tolerance vector.
- getRemainingRegion() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractSubHyperplane
-
Get the remaining region of the hyperplane.
- getRepresentation() - Method in class fr.cnes.sirius.patrius.math.genetics.AbstractListChromosome
-
Returns the (immutable) inner representation of the chromosome.
- getResidual() - Method in class fr.cnes.sirius.patrius.math.linear.DefaultIterativeLinearSolverEvent
-
Returns the residual.
- getResidual() - Method in class fr.cnes.sirius.patrius.math.linear.IterativeLinearSolverEvent
-
Returns the residual.
- getResiduals(double[]) - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.AbstractTLEFitter
-
Get the residuals for a given position/velocity/B* parameters set.
- getResizedB() - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the matrix B after reducing or extending it to match this matrix's dimensions.
- getResizedBT() - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the matrix BT after reducing or extending it to match this matrix's
dimensions.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Kurtosis
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Mean
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SecondMoment
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Skewness
-
Returns the value of the statistic based on the values that have been added.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Variance
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.VectorialCovariance
-
Get the covariance matrix.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.VectorialMean
-
Get the mean vector.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Max
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Min
-
Returns the current value of the Statistic.
- getResult() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StorelessUnivariateStatistic
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Product
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Sum
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfLogs
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfSquares
-
Returns the current value of the Statistic.
- getResult() - Method in class fr.cnes.sirius.patrius.tools.parallel.AbstractSimpleParallelTaskImpl
-
- getResult() - Method in interface fr.cnes.sirius.patrius.tools.parallel.ParallelTask
-
Asynchronous getter for the results.
- getResultSummary() - Method in class fr.cnes.sirius.patrius.tools.parallel.ParallelRunner
-
Gets the result summary.
- getReturnCode() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationResponse
-
Get the return code
- getReusabilityRatio() - Method in class fr.cnes.sirius.patrius.tools.cache.FIFOThreadSafeCache
-
Provides the ratio of reusability of this cache.
- getReuseExpense() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the expense of the re-use interval.
- getReverse() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Get the reverse of the instance.
- getRevolutionNumberAtEpoch() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the revolution number.
- getRho0() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
Getter for the Density at the altitude h0.
- getRhoFunction() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77Data
-
Getter for the 2D interpolator for density map.
- getRightAscensionOfAscendingNode() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the right ascension of the ascending node.
- getRightAscensionOfAscendingNode() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the right ascension of the ascending node.
- getRightAscensionOfAscendingNode() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the right ascension of the ascending node.
- getRightAscensionOfAscendingNode() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Get the right ascension of the ascending node.
- getRightAscensionOfAscendingNode() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Get the right ascension of the ascending node.
- getRightAscensionOfAscendingNode() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Get the right ascension of the ascending node.
- getRightAscensionOfAscendingNode() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Get the right ascension of the ascending node.
- getRightHandSideVector() - Method in class fr.cnes.sirius.patrius.math.linear.DefaultIterativeLinearSolverEvent
-
Returns the current right-hand side of the linear system to be solved.
- getRightHandSideVector() - Method in class fr.cnes.sirius.patrius.math.linear.IterativeLinearSolverEvent
-
Returns the current right-hand side of the linear system to be solved.
- getRMS() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
-
Gets the root-mean-square (RMS) value.
- getRMS() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.AbstractTLEFitter
-
Get Root Mean Square of the fitting.
- getRMS(double[]) - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.AbstractTLEFitter
-
Get the RMS for a given position/velocity/B* parameters set.
- getRollVelocity(SpacecraftState) - Method in class fr.cnes.sirius.patrius.attitudes.AeroAttitudeLaw
-
Getter for the roll velocity.
- getRoot() - Static method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the unique root frame.
- getRootMatrix() - Method in class fr.cnes.sirius.patrius.math.linear.RectangularCholeskyDecomposition
-
Get the root of the covariance matrix.
- getRootMatrix() - Method in class fr.cnes.sirius.patrius.math.random.CorrelatedRandomVectorGenerator
-
Get the root of the covariance matrix.
- getRootMatrix() - Method in class fr.cnes.sirius.patrius.math.random.UniformlyCorrelatedRandomVectorGenerator
-
Get the root of the correlation matrix.
- getRotatingFrame() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Getter for a body oriented, body centered frame.
- getRotatingFrame(IAUPoleModelType) - Method in class fr.cnes.sirius.patrius.bodies.AbstractIAUCelestialBody
-
Getter for a body oriented, body centered frame.
- getRotatingFrame() - Method in class fr.cnes.sirius.patrius.bodies.AbstractIAUCelestialBody
-
Getter for a body oriented, body centered frame.
- getRotatingFrame() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Getter for a body oriented, body centered frame.
- getRotatingFrame(IAUPoleModelType) - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Getter for a body oriented, body centered frame.
- getRotatingFrame(IAUPoleModelType) - Method in interface fr.cnes.sirius.patrius.bodies.IAUCelestialBody
-
Getter for a body oriented, body centered frame.
- getRotatingFrame() - Method in interface fr.cnes.sirius.patrius.bodies.IAUCelestialBody
-
Getter for a body oriented, body centered frame.
- getRotation() - Method in class fr.cnes.sirius.patrius.attitudes.Attitude
-
Get the attitude rotation.
- getRotation() - Method in class fr.cnes.sirius.patrius.attitudes.ConstantAttitudeLaw
-
Getter for the rotation from reference frame to satellite frame.
- getRotation() - Method in class fr.cnes.sirius.patrius.attitudes.LofOffset
-
Getter for the rotation from reference frame to satellite frame.
- getRotation() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the orientation of the "destination" frame in the "origin" one.
- getRotation() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Screw
-
- getRotation() - Method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Get the rotation.
- getRotationAcceleration() - Method in class fr.cnes.sirius.patrius.attitudes.Attitude
-
Get the satellite rotation acceleration.
- getRotationAcceleration() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the second time derivative of the rotation.
- getRotationAcceleration() - Method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Get the rotation acceleration.
- getRotationOrder() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EulerRotation
-
Getter for the order of rotations to use for (alpha1, alpha2, alpha3) composition.
- getRotationRate(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the rotation rate of the Earth.
- getRotationRate(AbsoluteDate, FramesConfiguration) - Static method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the rotation rate of the Earth.
- getRotationRate() - Method in class fr.cnes.sirius.patrius.frames.transformations.HelmertTransformation
-
Returns the first time derivative of the rotation (norm representing angular rate).
- getRotationRate() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the rotation rate of the "destination" frame in the "origin" one.
- getRotationRate() - Method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Get the rotation rate.
- getRotationVector() - Method in class fr.cnes.sirius.patrius.frames.transformations.HelmertTransformation
-
Returns the global rotation vector (applying rotation is done by computing cross product).
- getRoundingMode() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the current rounding mode.
- getRoundingMode() - Method in class fr.cnes.sirius.patrius.math.util.BigReal
-
Gets the rounding mode for division operations
The default is RoundingMode.HALF_UP
- getRow(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Get the entries in row number row as an array.
- getRow(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the entries of a given row.
- getRow(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Get the entries in row number row as an array.
- getRow(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Gets the entries of a given row.
- getRow(int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the entries of a given row.
- getRow(int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Get the entries in row number row as an array.
- getRow() - Method in exception fr.cnes.sirius.patrius.math.linear.NonPositiveDefiniteMatrixException
-
- getRow() - Method in exception fr.cnes.sirius.patrius.math.linear.NonSymmetricMatrixException
-
- getRow(int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the entries of a given row.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in interface fr.cnes.sirius.patrius.math.linear.AnyMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.JacobiPreconditioner
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class fr.cnes.sirius.patrius.math.linear.RealLinearOperator
-
Returns the dimension of the codomain of this operator.
- getRowInfinityNorm(RealMatrix, int) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.Matrix1NornRescaler
-
- getRowMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Get the entries in row number row as a row matrix.
- getRowMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the entries of a given row as a row matrix.
- getRowMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets the entries of a given row as a row matrix.
- getRowMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Get the entries in row number row as a row matrix.
- getRowMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Gets the entries of a given row as a row matrix.
- getRowMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets the entries of a given row as a row matrix.
- getRowMatrix(int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the entries of a given row as a row matrix.
- getRowMatrix(int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Get the entries in row number row as a row matrix.
- getRowMatrix(int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the entries of a given row as a row matrix.
- getRowPermutationIndexArray(AnyMatrix, int[]) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Builds a row permutation index array for a given matrix, starting with the preselected rows.
- getRowPrefix() - Method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Get the format prefix.
- getRowSeparator() - Method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Get the format separator between rows of the matrix.
- getRowSuffix() - Method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Get the format suffix.
- getRowVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Get the entries in row number row as a vector.
- getRowVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets the entries of a given row as a vector.
- getRowVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Get the entries in row number row as a vector.
- getRowVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Gets the entries of a given row as a vector.
- getRowVector(int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets the entries of a given row as a vector.
- getRowVector(int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Get the entries in row number row as a vector.
- getRowVector(int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets the entries of a given row as a vector.
- getRSquare() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
- getRSquared() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
- getRule(int) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.gauss.BaseRuleFactory
-
Gets a copy of the quadrature rule with the given number of integration
points.
- getRuleInternal(int) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.gauss.BaseRuleFactory
-
Gets a rule.
- getRuntimeClass() - Method in class fr.cnes.sirius.patrius.math.complex.ComplexField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in interface fr.cnes.sirius.patrius.math.Field
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFractionField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class fr.cnes.sirius.patrius.math.fraction.FractionField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class fr.cnes.sirius.patrius.math.util.BigRealField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class fr.cnes.sirius.patrius.math.util.Decimal64Field
-
Returns the runtime class of the FieldElement.
- getS() - Method in class fr.cnes.sirius.patrius.forces.gravity.BalminoGravityModel
-
- getS() - Method in class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
- getS() - Method in class fr.cnes.sirius.patrius.forces.gravity.DrozinerGravityModel
-
- getS(int, int, boolean) - Method in interface fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsProvider
-
Get tesseral-sectorial coefficients.
- getS(int, int, boolean) - Method in class fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsReader
-
Get tesseral-sectorial coefficients.
- getS() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Getter for the s-coordinate of pole.
- getS() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Returns the diagonal matrix Σ of the decomposition.
- getS10(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
Get the EUV index (26-34 nm) scaled to F10.
- getS10B(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
Get the EUV 81-day averaged centered index.
- getSafety() - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Get the safety factor for stepsize control.
- getSafety() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the safety factor for stepsize control.
- getSamples(boolean) - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the samples array.
- getSampleSize() - Method in class fr.cnes.sirius.patrius.math.distribution.HypergeometricDistribution
-
Access the sample size.
- getSampleSize() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the sample size.
- getSampleStats() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
- getSamplingStep() - Method in class fr.cnes.sirius.patrius.math.filter.FIRFilter
-
Getter for sampling step of the filter.
- getSatAddStatesSize(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
-
Get the additional states size of the given spacecraft .
- getSatellite() - Method in class fr.cnes.sirius.patrius.assembly.models.RFLinkBudgetModel
-
- getSatellite(String) - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
Get additional information about a satellite.
- getSatellite(String) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Get additional information about a satellite.
- getSatellite(int) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the nth satellite as contained in the SP3 file.
- getSatelliteCoordinates(String) - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
Get the time coordinates for the given satellite.
- getSatelliteCoordinates(String) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Get the time coordinates for the given satellite.
- getSatelliteCount() - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
Get the number of satellites contained in this orbit file.
- getSatelliteCount() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Get the number of satellites contained in this orbit file.
- getSatelliteId() - Method in class fr.cnes.sirius.patrius.files.general.SatelliteInformation
-
Returns the id for this satellite object.
- getSatelliteNumber() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Get the satellite id.
- getSatellites() - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
- getSatellites() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
- getSatId() - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedMonoEventDetector
-
Returns satellite ID.
- getSatRank(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
-
Get the state vector index of the given spacecraft in the global state vector.
- getSatSunVector(SpacecraftState) - Method in class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
-
Compute sat-Sun vector in spacecraft state frame.
- getSaturn() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Saturn singleton body.
- getScAbs() - Method in class fr.cnes.sirius.patrius.assembly.models.DragCoefficient
-
Get the absorption part in satellite frame.
- getScalAbsoluteTolerance() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Returns the scalar absolute tolerances.
- getScalarPart() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Gets the scalar part of the quaternion.
- getScale() - Method in class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Access the scale parameter.
- getScale() - Method in class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Returns the scale parameter of this distribution.
- getScale() - Method in class fr.cnes.sirius.patrius.math.distribution.LogNormalDistribution
-
Returns the scale parameter of this distribution.
- getScale() - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
Access the scale parameter, beta.
- getScale() - Method in class fr.cnes.sirius.patrius.math.util.BigReal
-
Sets the scale for division operations.
- getScaleFactor(double) - Method in class fr.cnes.sirius.patrius.projections.Mercator
-
Returns the scale factor at a specific latitude.
- getScalRelativeTolerance() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Returns the scalar relative tolerances.
- getScDiffAr() - Method in class fr.cnes.sirius.patrius.assembly.models.DragCoefficient
-
Get the diffuse part (rear) in satellite frame.
- getScDiffAv() - Method in class fr.cnes.sirius.patrius.assembly.models.DragCoefficient
-
Get the diffuse part (front) in satellite frame.
- getSchwarzschildRelativisticEffect() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getScSpec() - Method in class fr.cnes.sirius.patrius.assembly.models.DragCoefficient
-
Get the specular part in satellite frame.
- getSearchIndex() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractBoundedPVProvider
-
Getter for the optimize index search algorithm.
- getSearchMethod() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Getter for the search method.
- getSearchMethod() - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Getter for the search method.
- getSec() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Getter for sec.
- getSecond() - Method in class fr.cnes.sirius.patrius.math.genetics.ChromosomePair
-
Access the second chromosome.
- getSecond() - Method in class fr.cnes.sirius.patrius.math.util.Pair
-
Getter for the second element of the pair.
- getSecond() - Method in class fr.cnes.sirius.patrius.time.TimeComponents
-
Get the seconds number (it includes the fractional part of seconds).
- getSecondaryMappers() - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get the equations mappers for the secondary equations sets.
- getSecondarySpacecraft() - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Get the secondary assembly to consider.
- getSecondaryState(int) - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get secondary part of the current state.
- getSecondaryStateDot(int) - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get secondary part of the current state derivative.
- getSecondAxis() - Method in class fr.cnes.sirius.patrius.attitudes.TwoDirectionAttitudeLaw
-
Getter for the satellite axis aligned at best with the second direction.
- getSecondBody() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaThreeBodiesAngleDetector
-
Get 2nd body
- getSecondBody() - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
Get 2nd body.
- getSecondCovarianceMatrix() - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
- getSecondMoment() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns a statistic related to the Second Central Moment.
- getSecondMoment() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns a statistic related to the Second Central Moment.
- getSecondOrderDimension() - Method in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
-
Returns the number of second order additional states.
- getSecondOrderDimension() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Returns the number of second order additional states.
- getSecondOrderDimension() - Method in interface fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquations
-
Returns the number of second order additional states.
- getSecondsInDay(TimeScale) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Get the number of seconds within the day.
- getSecondsInDay() - Method in class fr.cnes.sirius.patrius.time.TimeComponents
-
Get the second number within the day.
- getSecondsOfWeek() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Returns the seconds of the GPS week as contained in the SP3 file.
- getSegment(int) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialProfile
-
Return an individual segment of the list, specified by the index.
- getSegments() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SubLine
-
Get the endpoints of the sub-line.
- getSegments() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.SubLine
-
Get the endpoints of the sub-line.
- getSegmentTable() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the segment list.
- getSelectedParameters() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Get a copy of the selected parameters.
- getSelectionPolicy() - Method in class fr.cnes.sirius.patrius.math.genetics.GeneticAlgorithm
-
Returns the selection policy.
- getSemiA() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Get the length of the semi principal axis X
- getSemiA() - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.IEllipsoid
-
Get semi axis A
- getSemiA() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Get semi axis A
- getSemiAxisA() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
This method returns the semi axis a
- getSemiAxisB() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
This method returns the semi axis b
- getSemiAxisX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This method returns the semi axis of the cone along X axis
- getSemiAxisY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This method returns the semi axis of the cone along Y axis
- getSemiB() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Get the length of the semi principal axis Y
- getSemiB() - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.IEllipsoid
-
Get semi axis B
- getSemiB() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Get semi axis B
- getSemiC() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Get the length of the semi principal axis Z
- getSemiC() - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.IEllipsoid
-
Get semi axis C
- getSemiC() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Get semi axis C
- getSemiPrincipalX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
- getSemiPrincipalY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
- getSemiPrincipalZ() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
- getSensor() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractStationToSatDetector
-
Get the sensor.
- getSensor() - Method in class fr.cnes.sirius.patrius.events.detectors.MaskingDetector
-
Get the sensor.
- getSensor() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Get the sensor.
- getSensor() - Method in class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Getter for the sensor.
- getSensor() - Method in class fr.cnes.sirius.patrius.events.detectors.TargetInFieldOfViewDetector
-
Get the sensor.
- getSensorMainSpacecraft() - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Get the main spacecraft sensor.
- getSensorName() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaSightAxisDetector
-
Get the sensor name.
- getSensorSecondarySpacecraft() - Method in class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Get the secondary spacecraft sensor.
- getSeparator() - Method in class fr.cnes.sirius.patrius.math.geometry.VectorFormat
-
Get the format separator between components.
- getSeparator() - Method in class fr.cnes.sirius.patrius.math.linear.RealVectorFormat
-
Get the format separator between components.
- getSeries(OneAxisEllipsoid) - Static method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoidUtils
-
Getter for the series.
- getSet() - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Getter
- getShape() - Method in class fr.cnes.sirius.patrius.assembly.properties.GeometricProperty
-
- getShape() - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Getter for the geometric shape of the body.
- getShape() - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Getter for the geometric shape of the body.
- getShape() - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Getter for the geometric shape of the body.
- getShape() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
Getter for the Body shape model.
- getShape() - Method in class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Returns the shape parameter of this distribution.
- getShape() - Method in class fr.cnes.sirius.patrius.math.distribution.LogNormalDistribution
-
Returns the shape parameter of this distribution.
- getShape() - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
Access the shape parameter, alpha.
- getShapiroTimeCorrection(CelestialPoint) - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Computes the Shapiro time dilation due to the gravitational attraction of the provided body.
- getShapiroTimeCorrection(double) - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getSideAxis() - Method in class fr.cnes.sirius.patrius.fieldsofview.PyramidalField
-
Get the side axis of the field of view.
- getSideAxis() - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
-
Get the 4 side axis of the field of view.
- getSideSlipAngle(SpacecraftState) - Method in class fr.cnes.sirius.patrius.attitudes.AeroAttitudeLaw
-
Getter for the side slip angle.
- getSightAxis(Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the sight axis of the sensor in a given frame at a date
- getSightAxis() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaSightAxisDetector
-
Get the sight axis
- getSigma() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.CMAESOptimizer.Sigma
-
- getSigma() - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
- getSigmaC(int, int, boolean) - Method in interface fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsProvider
-
Get the sigma tesseral-sectorial and zonal coefficients.
- getSigmaC(int, int, boolean) - Method in class fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsReader
-
Get the sigma tesseral-sectorial and zonal coefficients.
- getSigmaDirection() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.GatesModel
-
Gets the standard deviation σD on the direction (in radians).
- getSigmaMagnitude() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.GatesModel
-
Gets the standard deviation σM on the magnitude (in percent).
- getSigmaS(int, int, boolean) - Method in interface fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsProvider
-
Get tesseral-sectorial coefficients.
- getSigmaS(int, int, boolean) - Method in class fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsReader
-
Get tesseral-sectorial coefficients.
- getSignalDirection() - Method in class fr.cnes.sirius.patrius.attitudes.directions.LightAberrationTransformation
-
Getter for the signal direction.
- getSignalEmissionDate(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
- getSignalEmissionDate(PVCoordinatesProvider, PVCoordinatesProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
- getSignalEmissionDate(PVCoordinatesProvider, PVCoordinatesProvider, AbsoluteDate, double, AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Static method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagationModel
-
- getSignalEmissionDate(PVCoordinatesProvider, PVCoordinatesProvider, AbsoluteDate, double, AbstractSignalPropagationDetector.PropagationDelayType, Frame, int) - Static method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagationModel
-
- getSignalPropagationDuration() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getSignalReceptionDate(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
- getSignalReceptionDate(PVCoordinatesProvider, PVCoordinatesProvider, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
- getSignalReceptionDate(PVCoordinatesProvider, PVCoordinatesProvider, AbsoluteDate, double, AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Static method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagationModel
-
- getSignalReceptionDate(PVCoordinatesProvider, PVCoordinatesProvider, AbsoluteDate, double, AbstractSignalPropagationDetector.PropagationDelayType, Frame, int) - Static method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagationModel
-
- getSignificance() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the significance level of the slope (equiv) correlation.
- getSimpleConfiguration(boolean) - Static method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationFactory
-
Gets a simple configuration (always the same instance, not a new one).
- getSinArray() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
- getSinArrays() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesHarmonicProfile
-
Gets the b coefficients of the three Fourier series representing x, y and z.
- getSinArrays() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
- getSingularValues() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Returns the diagonal elements of the matrix Σ of the decomposition.
- getSize() - Method in class fr.cnes.sirius.patrius.attitudes.kinematics.AbstractOrientationFunction
-
- getSize() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesHarmonicProfile
-
Gets the size of the Fourierseries3DFunction, ie 3.
- getSize() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfileLeg
-
Gets the size of the Fourierseries3DFunction, ie 3.
- getSize() - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the size of the covariance matrix.
- getSize() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
-
- getSize() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Get the array size required for holding partial derivatives data.
- getSize() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGrid
-
Gets the number of grid points.
- getSize() - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.HermiteInterpolator
-
- getSize() - Method in interface fr.cnes.sirius.patrius.math.analysis.UnivariateVectorFunction
-
- getSize() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Interval
-
Get the size of the interval.
- getSize() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.SubOrientedPoint
-
Get the size of the instance.
- getSize() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractVector3DFunction
-
- getSize() - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3DFunction
-
- getSize() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Get the size of the instance.
- getSize() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractSubHyperplane
-
Get the size of the instance.
- getSize() - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Region
-
Get the size of the instance.
- getSize() - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.SubHyperplane
-
Get the size of the instance.
- getSize() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Get simplex size.
- getSize() - Method in class fr.cnes.sirius.patrius.math.util.MultidimensionalCounter
-
Get the total number of elements.
- getSize() - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalStateInfo
-
Get the size of the additional state.
- getSizes() - Method in class fr.cnes.sirius.patrius.math.util.MultidimensionalCounter
-
Get the number of multidimensional counter slots in each dimension.
- getSkewness() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the skewness of the available values.
- getSkewnessImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured skewness implementation.
- getSlope() - Method in class fr.cnes.sirius.patrius.math.fitting.LinearRegression
-
Get the slope B of the linear model y = A + B*x
- getSlope() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the slope of the estimated regression line.
- getSlope() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Getter for the slope of velocity.
- getSlopeConfidenceInterval() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the half-width of a 95% confidence interval for the slope
estimate.
- getSlopeConfidenceInterval(double) - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the half-width of a (100-100*alpha)% confidence interval for
the slope estimate.
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
Get the parameter in charge of the selection of detected events by the slope of the
g-function.
- getSlopeSelection() - Method in enum fr.cnes.sirius.patrius.events.detectors.ExtremaGenericDetector.ExtremumType
-
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get the parameter in charge of the selection of detected events by the slope of the
g-function.
- getSlopeSelection() - Method in interface fr.cnes.sirius.patrius.events.EventDetector
-
Get the parameter in charge of the selection of detected events by the slope of the
g-function.
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.MultiAbstractDetector
-
Get the parameter in charge of the selection of detected events by the slope of the g-function.
- getSlopeSelection() - Method in interface fr.cnes.sirius.patrius.events.MultiEventDetector
-
Get the parameter in charge of the selection of detected events by the slope of the g-function.
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
Get the parameter in charge of the selection of detected events by the slope of the
g-function.
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiGenericCodingEventDetector
-
Get the parameter in charge of the selection of detected events by the slope of the g-function.
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedEventDetector
-
Get the parameter in charge of the selection of detected events by the slope of the g-function.
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedMonoEventDetector
-
Get the parameter in charge of the selection of detected events by the slope of the g-function.
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedMultiEventDetector
-
Get the parameter in charge of the selection of detected events by the slope of the g-function.
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Get the parameter in charge of the selection of detected events by the slope of the
g-function.
- getSlopeSelection() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get the parameter in charge of the selection of detected events by the slope of the
g-function.
- getSlopeSelection() - Method in interface fr.cnes.sirius.patrius.math.ode.events.EventHandler
-
Get the parameter in charge of the selection of detected events by the slope of the g-function.
- getSlopeStdErr() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
- getSlots() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the number of slots in use.
- getSlotsEvictions() - Method in class fr.cnes.sirius.patrius.time.TimeStampedCache
-
Get the number of slots evictions.
- getSmallest() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.AVLTree
-
Get the node whose element is the smallest one in the tree.
- getSmaModel() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
Get the semi major axis parameter model.
- getSolActType() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.AbstractStelaSolarActivity
-
Get solar activity type.
- getSolActType() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaConstantSolarActivity
-
Get solar activity type.
- getSolActType() - Method in interface fr.cnes.sirius.patrius.stela.forces.solaractivity.IStelaSolarActivity
-
Get solar activity type.
- getSolarActivity() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
Getter for the solar activity.
- getSolarActivity(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaConstantSolarActivity
-
Get Solar activity coefficients at a specified date, in the following order: daily flux, mean flux, Ap1, Ap2,
Ap3, Ap4, Ap5, Ap6, Ap7.
- getSolarActivity(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaLOSConstantSolarActivity
-
Get Solar activity coefficients at a specified date, in the following order: daily flux, mean flux, Ap1, Ap2,
Ap3, Ap4, Ap5, Ap6, Ap7.
- getSolarActivity(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.stela.forces.solaractivity.IStelaSolarActivity
-
Get Solar activity coefficients at a specified date, in the following order: daily flux, mean flux, Ap1, Ap2,
Ap3, Ap4, Ap5, Ap6, Ap7.
- getSolarActivity(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableDispersedSolarActivity
-
Get Solar activity coefficients at a specified date, in the following order: daily flux, mean flux, Ap1, Ap2,
Ap3, Ap4, Ap5, Ap6, Ap7.
- getSolarActivity(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Get Solar activity coefficients at a specified date, in the following order: daily flux, mean flux, Ap1, Ap2,
Ap3, Ap4, Ap5, Ap6, Ap7.
- getSolarActivityCycles() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.Stela3StepsSolarActivity
-
Getter for the solar activity cycles list
- getSolarActivityCycles() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesData
-
Getter for the solar activity cycles list
- getSolarActivityCycles() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivity
-
Getter for the solar activity cycles list
- getSolarActivityDataProvider() - Static method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataFactory
-
Get the solar activity provider from the first supported file.
- getSolarActivityDataProvider() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getSolarActivityFirstDay() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesData
-
Getter for the solar activity first day.
- getSolarActivityFirstDay() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivity
-
Getter for the solar activity first day.
- getSolarAPMap() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivityReader
-
- getSolarFlux(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Compute solar flux.
- getSolarFluxMap() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivityReader
-
- getSolarPanelsList() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Returns the solar panels list.
- getSolarPanelsShape() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.VehicleSurfaceModel
-
Get solar panels.
- getSolarRadiationPressure() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getSolarSystemBarycenter() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the solar system barycenter aggregated body.
- getSolution() - Method in class fr.cnes.sirius.patrius.math.linear.DefaultIterativeLinearSolverEvent
-
Returns the current estimate of the solution to the linear system to be
solved.
- getSolution() - Method in class fr.cnes.sirius.patrius.math.linear.IterativeLinearSolverEvent
-
Returns the current estimate of the solution to the linear system to be
solved.
- getSolution() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationResponse
-
Get the solution
- getSolver() - Method in class fr.cnes.sirius.patrius.math.linear.CholeskyDecomposition
-
Gets a solver for finding the A × X = B solution in exact linear sense.
- getSolver() - Method in interface fr.cnes.sirius.patrius.math.linear.Decomposition
-
Gets a solver for finding the A × X = B solution in exact linear sense.
- getSolver() - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Gets a solver for finding the A × X = B solution in exact
linear sense.
- getSolver() - Method in class fr.cnes.sirius.patrius.math.linear.FieldLUDecomposition
-
Get a solver for finding the A × X = B solution in exact linear sense.
- getSolver() - Method in class fr.cnes.sirius.patrius.math.linear.LUDecomposition
-
Gets a solver for finding the A × X = B solution in exact linear sense.
- getSolver() - Method in class fr.cnes.sirius.patrius.math.linear.QRDecomposition
-
Gets a solver for finding the A × X = B solution in exact linear sense.
- getSolver() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Gets a solver for finding the A × X = B solution in exact linear sense.
- getSolver() - Method in interface fr.cnes.sirius.patrius.math.linear.UDDecomposition
-
Get a solver of the linear equation A × X = B for matrices A.
- getSolver() - Method in class fr.cnes.sirius.patrius.math.linear.UDDecompositionImpl
-
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractRealDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.BetaDistribution
-
Return the absolute accuracy setting of the solver used to estimate
inverse cumulative probabilities.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.ExponentialDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.FDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.LogNormalDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.NormalDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.TDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.TriangularDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformRealDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSolverAbsoluteAccuracy() - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
Return the absolute accuracy setting of the solver used to estimate
inverse cumulative probabilities.
- getSortedValues() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the current set of values in an array of double primitives,
sorted in ascending order.
- getSource() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceKernelInfo
-
Getter for the file source.
- getSourceString() - Method in class fr.cnes.sirius.patrius.math.exception.util.DummyLocalizable
-
Gets the source (non-localized) string.
- getSourceString() - Method in interface fr.cnes.sirius.patrius.math.exception.util.Localizable
-
Gets the source (non-localized) string.
- getSourceString() - Method in enum fr.cnes.sirius.patrius.utils.exception.PatriusMessages
-
Gets the source (non-localized) string.
- getSouth() - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the south direction of topocentric frame, expressed in the body frame of body shape to which the frame
center point is attached.
- getSP(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.PolarMotion
-
Compute S'.
- getsP() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Getter for the s-coordinate derivative of pole.
- getSP(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.sp.IERS2003SPCorrection
-
Compute the correction S' at a given date.
- getSP(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.sp.IERS2010SPCorrection
-
Compute the correction S' at a given date.
- getSP(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.sp.NoSpCorrection
-
Compute the correction S' at a given date.
- getSP(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.sp.SPrimeModel
-
Compute the correction S' at a given date.
- getSpace() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Get the space to which the vector belongs.
- getSpace() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the space to which the vector belongs.
- getSpace() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Get the space to which the vector belongs.
- getSpace() - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Get the space to which the vector belongs.
- getSpacecraftId() - Method in class fr.cnes.sirius.patrius.events.utils.EventState
-
Get the identifier of the spacecraft.
- getSpacecraftState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
- getSpacecraftState(AbsoluteDate, String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
- getSpacecraftState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
- getSpacecraftState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.Ephemeris
-
- getSpacecraftState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.IntegratedEphemeris
-
- getSpacecraftState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
- getSpacecraftState(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.SpacecraftStateProvider
-
- getSpacecraftState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
- getSpacecraftStateLight(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a static spacecraft state which only wraps a date.
- getSpecifier() - Method in exception fr.cnes.sirius.patrius.utils.exception.PatriusException
-
Get the localizable specifier of the error message.
- getSpecularReflectionCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
-
Get the parameter representing the specular reflection coefficient of the part.
- getSpecularReflectionRatio() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
-
Get the parameter representing the ratio of light subjected to specular reflectance : Ks = (1
- α) τ.
- getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Get the local speed of sound.
- getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.Atmosphere
-
Get the local speed of sound.
- getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.HarrisPriester
-
Get the local speed of sound.
- getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.JB2006
-
Get the local speed of sound.
- getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
Get the local speed of sound.
- getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
Get the local speed of sound.
- getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.US76
-
Get the local speed of sound.
- getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
Get the local speed of sound.
- getSphereArea() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
-
Get the sphere area.
- getSphereArea() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeSphereProperty
-
Get the sphere area.
- getSphereRadius() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
-
Get the sphere radius.
- getSphereRadius() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeSphereProperty
-
Get the sphere radius.
- getSphereRadius() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Getter for the encompassing sphere radius squared.
- getSphericalCoordinates() - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionDataPoint
-
Returns the spherical coordinates.
- getSphericalCoordinates() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Returns the spherical coordinates.
- getSpin() - Method in class fr.cnes.sirius.patrius.attitudes.Attitude
-
Get the satellite spin.
- getSpinDeltaT() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAttitudeProfile
-
Returns the delta-t used for spin computation by finite differences.
- getSpinDerivatives(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedSlew
-
Get spin derivatives.
- getSpinDerivativesComputation() - Method in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeLaw
-
Get the value of the flag indicating if spin derivation computation is activated.
- getSprime(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Compute S' value.
- getSprime(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Compute S' value.
- getSPrimeModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.PolarMotion
-
- getSqr2() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant √2.
- getSqr2Reciprocal() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant √2 / 2.
- getSqr2Split() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant √2 split in two pieces.
- getSqr3() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant √3.
- getSqr3Reciprocal() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant √3 / 3.
- getSqrtA() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getSquareRoot() - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Computes the square-root of the matrix.
- getSquaringJDCNES() - Method in class fr.cnes.sirius.patrius.stela.forces.Squaring
-
- getStandard() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.IOceanTidesDataProvider
-
Get the ocean tides standard
- getStandard() - Method in interface fr.cnes.sirius.patrius.forces.gravity.tides.ITerrestrialTidesDataProvider
-
- getStandard() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.OceanTidesDataProvider
-
Get the ocean tides standard
- getStandard() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.TerrestrialTidesDataProvider
- getStandardA() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the final equalities constraints coefficients
- getStandardB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the final equalities constraints limits
- getStandardBasisTransform() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Get transformation matrix (from ellipsoid local basis to standard basis)
- getStandardBasisTransform() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
This method returns the matrix of the transformation to the standard basis
- getStandardBasisTransform() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
This method returns the matrix of the transformation to the standard basis
- getStandardC() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the final objective function
- getStandardComponents(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Express a vector in the original variables in the final standard variable form
- getStandardDeviation(int) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the standard deviation σi = sqrt(Ci,i) for the
specified row/column index.
- getStandardDeviation(ParameterDescriptor) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the standard deviation σi = sqrt(Ci,i) associated
with the specified parameter descriptor.
- getStandardDeviation(UnivariateFunction, UnivariateFunction, double[]) - Static method in class fr.cnes.sirius.patrius.math.analysis.ErrorEvaluationFunctionUtils
-
Compute the standard deviation σ between the function to evaluate and the approximated function at the
considered abscissas.
- getStandardDeviation(double[], double[], UnivariateFunction) - Static method in class fr.cnes.sirius.patrius.math.analysis.ErrorEvaluationFunctionUtils
-
Compute the standard deviation σ between the function to evaluate and the approximated function at the
considered abscissas.
- getStandardDeviation() - Method in class fr.cnes.sirius.patrius.math.distribution.NormalDistribution
-
Access the standard deviation.
- getStandardDeviation() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
- getStandardDeviation() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
standard deviation of the ith entries of the arrays
that correspond to each multivariate sample
- getStandardDeviation() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummary
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummaryValues
-
- getStandardDeviation() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the standard deviation of the values that have been added.
- getStandardDeviation() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getStandardDeviation() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the standard deviation of the values that have been added.
- getStandardDeviationMatrix() - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the standard deviation matrix.
- getStandardDeviations() - Method in class fr.cnes.sirius.patrius.math.distribution.MultivariateNormalDistribution
-
Gets the square root of each element on the diagonal of the covariance
matrix.
- getStandardDeviationTime() - Method in class fr.cnes.sirius.patrius.utils.TimeIt
-
Returns the standard deviation of the computation time it takes to perform the function to benchmark (evaluated
on a batch of
N loops).
- getStandardDeviationVector() - Method in class fr.cnes.sirius.patrius.math.random.UniformlyCorrelatedRandomVectorGenerator
-
Get the standard deviation vector.
- getStandardLB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the final lower bounds
This makes sense only if strictlyStandardForm = false (otherwise all lb are 0).
- getStandardLineSeparator() - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Getter for the String representing the standard line separator.
- getStandardModel(double) - Static method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.SaastamoinenModel
-
Create a new Saastamoinen model using a standard atmosphere model.
- getStandardN() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the final number of variables
- getStandardS() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the final number of slack variables for inequalities constraints
- getStandardUB() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the final upper bounds
This makes sense only if strictlyStandardForm = false (otherwise all ub are unbounded).
- getStart() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the Chebyshev polynomial range start date.
- getStart() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialChebyshevFunction
-
Getter for the start range.
- getStart() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Segment
-
Get the start point of the segment.
- getStart() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Segment
-
Get the start point of the segment.
- getStartAsDouble() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the start range of the underlying polynomial Chebyshev function.
- getStartDate() - Method in class fr.cnes.sirius.patrius.attitudes.SpinStabilized
-
Getter for the start date of the rotation.
- getStartDate() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Return the maneuver start date (if a date or a
DateDetector as been provided).
- getStartDate() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Return the maneuver start date (if a date or a
DateDetector as been provided).
- getStartDate() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Get the date of the first available Earth Orientation Parameters.
- getStartDate() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
-
- getStartDate() - Method in interface fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistory
-
Get the date of the first available Earth Orientation Parameters.
- getStartDate() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NoEOP2000History
-
getStartDate.
- getStartDate() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Get start date.
- getStarterIntegrator() - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Get the starter integrator.
- getStartIndex() - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Returns the "start index" of the internal array.
- getStartingEvent() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Phenomenon
-
Get the starting event.
- getStartingIsDefined() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Phenomenon
-
True if the first boundary value is defined.
- getStartPoint() - Method in class fr.cnes.sirius.patrius.math.optim.BaseMultivariateOptimizer
-
Gets the initial guess.
- getStartValue() - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
- getStartValue() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.SearchInterval
-
Gets the start value.
- getStartValue() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.UnivariateOptimizer
-
- getState() - Method in class fr.cnes.sirius.patrius.events.postprocessing.CodedEventsLogger.LoggedCodedEvent
-
- getState() - Method in class fr.cnes.sirius.patrius.events.postprocessing.EventsLogger.LoggedEvent
-
Get the triggering state.
- getStateDimension() - Method in class fr.cnes.sirius.patrius.math.filter.KalmanFilter
-
Returns the dimension of the state estimation vector.
- getStateDimension() - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the state vector dimension.
- getStateEstimation() - Method in class fr.cnes.sirius.patrius.math.filter.KalmanFilter
-
Returns the current state estimation vector.
- getStateEstimationVector() - Method in class fr.cnes.sirius.patrius.math.filter.KalmanFilter
-
Returns a copy of the current state estimation vector.
- getStateJacobian(SpacecraftState, double[][]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to state.
- getStateJacobian(SpacecraftState, double[][], OrbitType, PositionAngle, Frame) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to state.
- getStateJacobian(SpacecraftState) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to state.
- getStateJacobian(SpacecraftState, OrbitType, PositionAngle, Frame) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Get the Jacobian with respect to state.
- getStateProviders() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Get the map of additional spacecraft state providers
- getStateRelativeToBody(String, double, String, String, double[]) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkReader
-
Return the state (position and velocity) of a target body relative to an observing body.
- getStateRelativeToCenterOfMotion(int, double[], double, int[], int[]) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkReader
-
Return, for a specified SPK segment and time, the state (position and velocity) of the segment's target body
relative to its center of motion.
- getStates() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiCodedEventsLogger.MultiLoggedCodedEvent
-
- getStates() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiEventsLogger.MultiLoggedEvent
-
Get the triggering states.
- getStateTransitionMatrix() - Method in class fr.cnes.sirius.patrius.math.filter.DefaultProcessModel
-
Returns the state transition matrix.
- getStateTransitionMatrix() - Method in interface fr.cnes.sirius.patrius.math.filter.ProcessModel
-
Returns the state transition matrix.
- getStateVectorIndex() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialCoordinate
-
Gets the index of the coordinate in the state vector array.
- getStateVectorIndex() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeCoordinate
-
Gets the index of the coordinate in the state vector array.
- getStateVectorIndex() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusCoordinate
-
Gets the index of the coordinate in the state vector array.
- getStateVectorIndex() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianCoordinate
-
Gets the index of the coordinate in the state vector array.
- getStateVectorIndex() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularCoordinate
-
Gets the index of the coordinate in the state vector array.
- getStateVectorIndex() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialCoordinate
-
Gets the index of the coordinate in the state vector array.
- getStateVectorIndex() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialCoordinate
-
Gets the index of the coordinate in the state vector array.
- getStateVectorIndex() - Method in enum fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianCoordinate
-
Gets the index of the coordinate in the state vector array.
- getStateVectorIndex() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.OrbitalCoordinate
-
Gets the index of the coordinate in the state vector array.
- getStateVectorSize() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
-
Get global state vector size.
- getStateVectorSize() - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get the state vector size.
- getStatInformation(double) - Static method in class fr.cnes.sirius.patrius.stela.forces.drag.AbstractStelaDragCoef
-
Get statistical drag coefficient information.
- getStatInformation() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaConstantDragCoef
-
Get statistical drag coefficient information.
- getStatInformation() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDispersedDragCoef
-
Get statistical coefficient information.
- getStatInformation() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDispersedDragCoef
-
Get statistical coefficient information.
- getStation() - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractStationToSatDetector
-
Get the station.
- getStationBodyPoint() - Method in class fr.cnes.sirius.patrius.events.detectors.VisibilityFromStationDetector
-
Getter for the station body point.
- getStatisticsDHistory() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- getStatisticsFitnessHistory() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- getStatisticsMeanHistory() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- getStatisticsSigmaHistory() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- getStdErrorOfEstimate(int) - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
- getStdErrorOfEstimates() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
- getStelaConfiguration() - Static method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationFactory
-
Gets the official STELA configuration (always the same instance, not a new one).
- getStelaDoubleFormat() - Static method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.AbstractStelaSolarActivity
-
Get the Stela decimal format
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.AlternateEquinoctialParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisAltitudeParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ApsisRadiusParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters(double) - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CircularParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquinoctialParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in interface fr.cnes.sirius.patrius.orbits.orbitalparameters.IOrbitalParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStelaEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Convert current orbital parameters into Stela equinoctial parameters.
- getStep() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get the detection step.
- getStepApKp() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Returns the step for Ap/Kp values.
- getStepApKp() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Returns the step for Ap/Kp values.
- getStepApKp() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Returns the step for Ap/Kp values.
- getStepApKp() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Returns the step for Ap/Kp values.
- getStepF107() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ConstantSolarActivity
-
Returns the step for F107 values.
- getStepF107() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
-
Returns the step for F107 values.
- getStepF107() - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataProvider
-
Returns the step for F107 values.
- getStepF107() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Returns the step for F107 values.
- getStepHandlers() - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Get all the step handlers that have been added to the integrator.
- getStepHandlers() - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Get all the step handlers that have been added to the integrator.
- getStepHandlers() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Provides a list of step handlers to be performed during propagation.
- getStepHandlers() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Provides a list of step handlers to be performed during propagation.
- getStepSize() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.FiniteDifferencesDifferentiator
-
Get the step size.
- getStrengthLevel() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
Get the strength level for activity.
- getStrict() - Method in exception fr.cnes.sirius.patrius.math.exception.NonMonotonicSequenceException
-
- getString() - Method in class fr.cnes.sirius.patrius.utils.TimeStampedString
-
Get the string (first component of the array if it was constructed with an array).
- getStringAlign() - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Getter for the text alignment mode.
- getStrings() - Method in class fr.cnes.sirius.patrius.utils.TimeStampedString
-
Get the strings.
- getStrVals(String) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.PoolSpice
-
Return the character value of a kernel variable from the kernel pool.
- getSubCovariance(int[]) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Extracts the parts of the covariance associated with the specified row/column indices.
- getSubCovariance(Collection<ParameterDescriptor>) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Extracts the parts of the covariance associated with the specified parameter descriptors.
- getSubMatrix(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Get a submatrix.
- getSubMatrix(int[], int[]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Gets a submatrix.
- getSubMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int[]) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Gets a submatrix.
- getSubMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int[]) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets a submatrix.
- getSubMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int[]) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Gets a submatrix.
- getSubMatrix(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int[]) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int, int, int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Get a submatrix.
- getSubMatrix(int[], int[]) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int[]) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricPositiveMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubMatrix(int[]) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricPositiveMatrix
-
Extracts the submatrix corresponding to the specified indices.
- getSubSpace() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Euclidean1D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Euclidean3D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Euclidean2D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in interface fr.cnes.sirius.patrius.math.geometry.Space
-
Get the n-1 dimension subspace of this space.
- getSubVector(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Get a subvector from consecutive elements.
- getSuffix() - Method in class fr.cnes.sirius.patrius.math.geometry.VectorFormat
-
Get the format suffix.
- getSuffix() - Method in class fr.cnes.sirius.patrius.math.linear.RealMatrixFormat
-
Get the format suffix.
- getSuffix() - Method in class fr.cnes.sirius.patrius.math.linear.RealVectorFormat
-
Get the format suffix.
- getSum() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns the sum of the values that have been added to Univariate.
- getSum() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the sum of the values that have been added to Univariate.
- getSum() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
- getSum() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
sum of the ith entries of the arrays
that correspond to each multivariate sample
- getSum() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummary
-
Returns the sum of the values that have been added to Univariate.
- getSum() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummaryValues
-
- getSum() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the sum of the values that have been added
- getSum() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getSum() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the sum of the values that have been added
- getSumFreq() - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the sum of all frequencies.
- getSumImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured sum implementation.
- getSumImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured Sum implementation
- getSumImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the currently configured Sum implementation
- getSumImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured Sum implementation
- getSumImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured Sum implementation
- getSumLog() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
- getSumLog() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
sum of logs of the ith entries of the arrays
that correspond to each multivariate sample
- getSumLog() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getSumLogImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Returns the currently configured sum of logs implementation
- getSumLogImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured sum of logs implementation
- getSumLogImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the currently configured sum of logs implementation
- getSumLogImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured sum of logs implementation
- getSumLogImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured sum of logs implementation
- getSummary() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
- getSummary() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
- getSummary() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
- getSummaryFormatDAF(int) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafHandle
-
Return the summary format associated with a handle.
- getSummaryOfArray() - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.FindArraysDAF
-
Return (get) the summary for the current array in the current DAF.
- getSumOfCrossProducts() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the sum of crossproducts, xi*yi.
- getSumOfLogs() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns the sum of the logs of all the aggregated data.
- getSumOfLogs() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the sum of the logs of the values that have been added.
- getSumsq() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns the sum of the squares of all the aggregated data.
- getSumsq() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the sum of the squares of the available values.
- getSumSq() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
- getSumSq() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
sum of squares of the ith entries of the arrays
that correspond to each multivariate sample
- getSumsq() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the sum of the squares of the values that have been added.
- getSumSq() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
- getSumsq() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the sum of the squares of the values that have been added.
- getSumsqImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured sum of squares implementation.
- getSumsqImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Returns the currently configured sum of squares implementation
- getSumsqImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the currently configured sum of squares implementation
- getSumsqImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Returns the currently configured sum of squares implementation
- getSumsqImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured sum of squares implementation
- getSumSquaredErrors() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
- getSun() - Method in class fr.cnes.sirius.patrius.attitudes.YawSteering
-
Returns the Sun.
- getSun() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Sun singleton body.
- getSun() - Method in class fr.cnes.sirius.patrius.events.detectors.LocalTimeAngleDetector
-
Return the sun
- getSun() - Method in class fr.cnes.sirius.patrius.events.detectors.NadirSolarIncidenceDetector
-
Getter for the Sun.
- getSun() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Getter for the sun position.
- getSun() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
Getter for the Sun.
- getSun() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
Getter for the sun.
- getSun() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
-
Get the Sun.
- getSunBody() - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Getter for the Sun model used at construction.
- getSunThirdBodyAttraction() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getSup() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Interval
-
Get the upper bound of the interval.
- getSup() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.IntervalsSet
-
Get the highest value belonging to the instance.
- getSupport() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.cowell.CowellIntegrator
-
Returns the integration support.
- getSupportedNames() - Method in class fr.cnes.sirius.patrius.bodies.AbstractJPLCelestialBodyLoader
-
Returns the supported file names.
- getSupportedNames() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Get the regular expression for supported files names.
- getSupportedNames() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
Get the supported names for data files.
- getSupportedNames() - Method in class fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsReader
-
Get the regular expression for supported files names.
- getSupportedNames() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
-
Get the regular expression for supported files names.
- getSupportedNames() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
Get the regular expression for supported files names.
- getSupportedNames() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticModelReader
-
Get the regular expression for supported files names.
- getSupportedNames() - Method in class fr.cnes.sirius.patrius.time.UTCTAIHistoryFilesLoader
-
Get the regular expression for supported files names.
- getSupportedNames() - Method in interface fr.cnes.sirius.patrius.time.UTCTAILoader
-
Get the regular expression for supported UTC-TAI offsets files names.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.BetaDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.BinomialDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.ExponentialDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.FDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.HypergeometricDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in interface fr.cnes.sirius.patrius.math.distribution.IntegerDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.LogNormalDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.NormalDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.PascalDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.PoissonDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in interface fr.cnes.sirius.patrius.math.distribution.RealDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.TDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.TriangularDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformIntegerDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformRealDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.distribution.ZipfDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Access the lower bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.BetaDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.BinomialDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.CauchyDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.ChiSquaredDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.ExponentialDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.FDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.HypergeometricDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in interface fr.cnes.sirius.patrius.math.distribution.IntegerDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.LogNormalDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.NormalDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.PascalDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.PoissonDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in interface fr.cnes.sirius.patrius.math.distribution.RealDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.TDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.TriangularDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformIntegerDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformRealDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.WeibullDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.distribution.ZipfDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Access the upper bound of the support.
- getSurface() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Getter for the triangle surface.
- getSurface() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Get surface
- getSurfaceFromRadius(double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Get surface from radius value.
- getSurfX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularSurfaceCylinder
-
Get surface perpendicular to X axis (m2).
- getSurfX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Get surface perpendicular to X axis.
- getSurfY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Get surface perpendicular to Y axis.
- getSurfZ() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Get surface perpendicular to Z axis.
- getSw(int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Flags
-
Getter for a particular element in the sw array.
- getSwc(int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Flags
-
Getter for a particular element in the swc array.
- getSwitches() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Flags
-
Getter for switches.
- getT() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Output
-
Getter for temperature (t).
- getT(int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Output
-
Getter for temperature component.
- getT0() - Method in class fr.cnes.sirius.patrius.events.utils.EventState
-
Getter for t0.
- getT0() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the Chebyshev polynomial origin date.
- getT0() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunction
-
Returns the model origin date.
- getT0() - Method in interface fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunctionInterface
-
Getter for the origin date.
- getT0() - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Getter for t0.
- getT1() - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
- getT2() - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
- getTab() - Method in class fr.cnes.sirius.patrius.math.utils.AbstractSearchIndex
-
Returns the array of values.
- getTab() - Method in interface fr.cnes.sirius.patrius.math.utils.ISearchIndex
-
Returns the array of values.
- getTabDensity() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.HarrisPriester
-
Getter for the current density table.
- getTabulatedAttitude() - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Getter for the tabulated attitude leg representing the celestial body orientation.
- getTAI() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the International Atomic Time scale.
- getTangentialCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
-
Get the normal force parametrizable function.
- getTank(String) - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Public method to search the tank object corresponding to the specified name.
- getTankCount() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
- getTankProperty() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the tank property.
- getTankProperty() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get the tank property.
- getTanksList() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Returns the tanks list.
- getTarget() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.MultivariateVectorOptimizer
-
Gets the observed values to be matched by the objective vector
function.
- getTarget() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.Target
-
Gets the initial guess.
- getTarget() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.AbstractTLEFitter
-
Get the position/velocity target at sample points.
- getTargetCenterFOVAngle(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the angular distance of the CENTER of the main target to the border of the main field
of view at a date.
- getTargetCenterFOVAngle(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the angular distance of the CENTER of the main target to the border of the main field of view at
sensor's reception date.
- getTargetDihedralAngles(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the dihedral angles of the target at a date in the sensor's frame.
- getTargetPoint() - Method in class fr.cnes.sirius.patrius.attitudes.TargetGroundPointing
-
Getter for the target point.
- getTargetPoint() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaSightAxisDetector
-
Get the target point.
- getTargetPosition(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointing
-
Compute the target ground point position in specified frame.
- getTargetPosition(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointingWrapper
-
Compute the target ground point position in specified frame.
- getTargetPosition(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.BodyCenterGroundPointing
-
Compute the target ground point position in specified frame.
- getTargetPosition(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.LofOffsetPointing
-
Compute the target ground point position in specified frame.
- getTargetPosition(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.NadirPointing
-
Compute the target ground point position in specified frame.
- getTargetPosition(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.TargetGroundPointing
-
Compute the target ground point position in specified frame.
- getTargetPV(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointing
-
Compute the target point position/velocity in specified frame.
- getTargetPV(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointingWrapper
-
Compute the target point position/velocity in specified frame.
- getTargetPV(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.NadirPointing
-
Compute the target point position/velocity in specified frame.
- getTargetPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthCenterDirection
-
Provides the target point at a given date in a given frame, represented by the
associated PVCoordinates object.
- getTargetPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthToCelestialPointDirection
-
Provides the target point at a given date in a given frame, represented by the
associated PVCoordinates object.
- getTargetPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GenericTargetDirection
-
Provides the target point at a given date in a given frame, represented by the
associated PVCoordinates object.
- getTargetPVCoordinates(AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.attitudes.directions.ITargetDirection
-
Provides the target point at a given date in a given frame, represented by the
associated PVCoordinates object.
- getTargetPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.ToCelestialPointDirection
-
Provides the target point at a given date in a given frame, represented by the
associated PVCoordinates object.
- getTargetPvProvider() - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthCenterDirection
-
- getTargetPvProvider() - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthToCelestialPointDirection
-
- getTargetPvProvider() - Method in class fr.cnes.sirius.patrius.attitudes.directions.GenericTargetDirection
-
- getTargetPvProvider() - Method in interface fr.cnes.sirius.patrius.attitudes.directions.ITargetDirection
-
- getTargetPvProvider() - Method in class fr.cnes.sirius.patrius.attitudes.directions.ToCelestialPointDirection
-
- getTargetRefAxisAngle(AbsoluteDate, int) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getTargetRefAxisElevation(AbsoluteDate, int) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getTargetSightAxisAngle(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getTargetSightAxisElevation(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
- getTargetSize() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.MultivariateVectorOptimizer
-
Gets the number of observed values.
- getTargetVectorInSensorFrame(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the target vector at a date in the sensor's frame.
- getTargetVectorInSensorFrame(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the target vector in the sensor's frame.
- getTaskInfo() - Method in class fr.cnes.sirius.patrius.tools.parallel.AbstractSimpleParallelTaskImpl
-
- getTaskInfo() - Method in interface fr.cnes.sirius.patrius.tools.parallel.ParallelTask
-
Returns human-readable info on the status of the task.
- getTaskLabel() - Method in class fr.cnes.sirius.patrius.tools.parallel.AbstractSimpleParallelTaskImpl
-
- getTaskLabel() - Method in interface fr.cnes.sirius.patrius.tools.parallel.ParallelTask
-
Returns a label identifying the task "class".
- getTaylorCoeffs() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
-
Getter for the Taylor coefficients (up to the 2nd order) of the eccentricity function G(e).
- getTCB() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the Barycentric Coordinate Time scale.
- getTCG() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the Geocentric Coordinate Time scale.
- getTDB() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the Barycentric Dynamic Time scale.
- getTechnoLoss() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
-
- getTEME() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the TEME reference frame.
- getTemp(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.US76
-
Getter for the local temperature for altitude in interval [0, 1E6]m.
- getTemperature() - Method in class fr.cnes.sirius.patrius.events.detectors.ApparentElevationDetector
-
Get the local temperature at topocentric frame origin.
- getTemperature() - Method in class fr.cnes.sirius.patrius.signalpropagation.MeteorologicalConditions
-
Getter for the temperature [°K].
- getTemperature(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
Getter for the temperature at the local point.
- getTemperature() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.JacchiaOutput
-
Getter for the atmospheric temperature.
- getTemperature() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaDragCoefInput
-
Getter for temperature of the atmosphere.
- getTempFunction() - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77Data
-
Getter for the 2D interpolator for temperature map.
- getTerrestrialTides() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getTheta() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGridPoint
-
Gets the inclination angle between 0° (included) and 180° (included).
- getThirdBody() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaThreeBodiesAngleDetector
-
Get 3rd body
- getThirdBody() - Method in class fr.cnes.sirius.patrius.events.detectors.ThreeBodiesAngleDetector
-
Get 3rd body.
- getThreeHourlyKP(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.DTMInputParameters
-
Get the value of the 3 hours geomagnetic index.
- getThreeHourlyKP(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.DTMSolarData
-
Get the value of the 3 hours geomagnetic index.
- getThreeHourlyKP(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
Get the value of the 3 hours geomagnetic index.
- getThreshold() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the threshold for apparent radius determination convergence.
- getThreshold() - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
Get the convergence threshold in the event time search.
- getThreshold() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
Get the convergence threshold in the event time search.
- getThreshold() - Method in interface fr.cnes.sirius.patrius.events.EventDetector
-
Get the convergence threshold in the event time search.
- getThreshold() - Method in class fr.cnes.sirius.patrius.events.MultiAbstractDetector
-
Get the convergence threshold in the event time search.
- getThreshold() - Method in interface fr.cnes.sirius.patrius.events.MultiEventDetector
-
Get the convergence threshold in the event time search.
- getThreshold() - Method in class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
Get the convergence threshold in the event time search.
- getThreshold() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiGenericCodingEventDetector
-
Get the convergence threshold in the event time search.
- getThreshold() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Get the convergence threshold in the event time search.
- getThreshold() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get the convergence threshold in the event time search.
- getThreshold() - Method in exception fr.cnes.sirius.patrius.math.linear.NonPositiveDefiniteMatrixException
-
- getThreshold() - Method in exception fr.cnes.sirius.patrius.math.linear.NonSymmetricMatrixException
-
- getThreshold() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Getter for the threshold used in the convergence algorithm to compute the correction from the geometric
elevation.
- getThrowable() - Method in class fr.cnes.sirius.patrius.math.exception.util.ExceptionContext
-
Get a reference to the exception to which the context relates.
- getThrust() - Method in class fr.cnes.sirius.patrius.assembly.properties.PropulsiveProperty
-
- getThrust(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.properties.PropulsiveProperty
-
- getThrust(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the thrust.
- getThrustParam() - Method in class fr.cnes.sirius.patrius.assembly.properties.PropulsiveProperty
-
Getter for the thrust force as an
Parameter object.
- getTidalCorrectionModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.DiurnalRotation
-
- getTidalCorrectionModel() - Method in class fr.cnes.sirius.patrius.frames.configuration.PolarMotion
-
- getTiesStrategy() - Method in class fr.cnes.sirius.patrius.math.stat.ranking.NaturalRanking
-
Return the TiesStrategy
- getTime() - Method in class fr.cnes.sirius.patrius.events.detectors.LocalTimeAngleDetector
-
Get local time angle to detect.
- getTime() - Method in class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Get solar time angle to detect.
- getTime() - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Get current time.
- getTime() - Method in class fr.cnes.sirius.patrius.time.DateTimeComponents
-
Get the time component.
- getTimeDependency() - Method in class fr.cnes.sirius.patrius.bodies.IAUPoleFunction
-
Returns the IAU time dependency (days or centuries).
- getTimeDerivativesList() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Returns time derivatives list.
- getTimeFactor() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialChebyshevFunction
-
Getter for the time factor.
- getTimeFactor() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunction
-
Getter for the time factor.
- getTimeFactor() - Method in interface fr.cnes.sirius.patrius.math.analysis.polynomials.DatePolynomialFunctionInterface
-
Getter for the time factor.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeEphemerisGenerator
-
Returns the underlying sequence time interval.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeLawLeg
-
Returns the time interval of the leg.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Returns the time interval of the leg.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.orientations.AbstractOrientationAngleLeg
-
Returns the time interval of the leg.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLegsSequence
-
Returns the time interval of the legs sequence.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfileSequence
-
Returns the time interval of the legs sequence.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAttitudeProfile
-
Returns the time interval of the leg.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Returns the time interval of the legs sequence.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfilesSequence
-
Returns the time interval of the legs sequence.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialSegment
-
Get the time interval of the guidance profile segment.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialSegment
-
Get the time interval of the guidance profile segment.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.RelativeTabulatedAttitudeLeg
-
Returns the time interval of the leg.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Returns the time interval of the leg.
- getTimeInterval() - Method in interface fr.cnes.sirius.patrius.utils.legs.Leg
-
Returns the time interval of the leg.
- getTimeInterval() - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Returns the time interval of the legs sequence.
- getTimeInterval() - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Returns the time interval of the legs sequence.
- getTimeIntervalOfValidity() - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Time interval of validity for the EOP files.
- getTimeIntervalOfValidity() - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Time interval of validity for the EOP files.
- getTimes() - Method in class fr.cnes.sirius.patrius.utils.TimeIt
-
Returns the computation times it takes to perform the function to benchmark on each batch of "nbLoops" runs.
- getTimeScale() - Method in class fr.cnes.sirius.patrius.events.detectors.RelativeDateDetector
-
Getter for the time scale of the event.
- getTimespan() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Phenomenon
-
Get the timespan as an AbsoluteDateInterval.
- getTimeStampedPVCoordinates(boolean) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Getter for the time-stamped PVCoordinates array.
- getTimeStampedPVCoordinatesSize() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Getter for the time-stamped PVCoordinates size.
- getTimeSystem() - Method in interface fr.cnes.sirius.patrius.files.general.OrbitFile
-
- getTimeSystem() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
- getTIRF() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the TIRF reference frame.
- getTLE() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.AbstractTLEFitter
-
Get the fitted Two-Lines Elements.
- getTLE(double[]) - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.AbstractTLEFitter
-
Get the TLE for a given position/velocity/B* parameters set.
- getTLE() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
Get the underlying TLE.
- getTloc(Vector3D, Vector3D, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.bodies.GeodPosition
-
Compute the local solar time at a given date.
- getTOD(boolean) - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the TOD reference frame.
- getTolerance() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the tolerance for the minimum value.
- getTolerance() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the tolerance for the minimum value
- getToleranceFeas() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the tolerance for the constraints satisfaction.
- getToleranceFeas() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the tolerance for the constraints satisfaction
- getToleranceInnerStep() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the tolerance for inner iterations in the barrier-method.
- getToleranceInnerStep() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the tolerance for inner iterations in the barrier-method.
- getToleranceKKT() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Get the acceptable tolerance for KKT system resolution
- getToleranceKKT() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Get the acceptable tolerance for KKT system resolution
- getTopocentricFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.ApparentElevationDetector
-
Get the topocentric frame.
- getTopocentricFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.ElevationDetector
-
Get the topocentric frame.
- getTopocentricFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaElevationDetector
-
- getTopocentricFrame() - Method in class fr.cnes.sirius.patrius.events.detectors.GroundMaskElevationDetector
-
Get the topocentric frame.
- getTopocentricPosition() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPV
-
Get the Topocentric position.
- getTopoFrame() - Method in class fr.cnes.sirius.patrius.groundstation.GeometricStationAntenna
-
- getTorque() - Method in class fr.cnes.sirius.patrius.wrenches.Wrench
-
- getTorque(Vector3D) - Method in class fr.cnes.sirius.patrius.wrenches.Wrench
-
Get the torque expressed in another point.
- getTotalContribution() - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
-
Getter for the sum of all contributions to dE'/dt (E' = mean orbital parameters).
- getTotalContributionSTM() - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
-
Getter for the sum of all contributions to dSTM/dt (STM = state transition matrix).
- getTotalDimension() - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Return the dimension of the complete set of equations.
- getTotalIntensity() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticElements
-
Returns the total intensity of the magnetic field (= norm of the field vector).
- getTotalMass() - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
-
Return the mass of the spacecraft.
- getTotalMass(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
-
Return the mass of the spacecraft following the order.
- getTotalMass() - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
-
Return the mass of the spacecraft.
- getTotalMass(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
-
Return the mass of the spacecraft following the order.
- getTotalMass() - Method in class fr.cnes.sirius.patrius.assembly.models.MassModel
-
Return the mass of the spacecraft.
- getTotalMass(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.models.MassModel
-
Return the mass of the spacecraft following the order.
- getTotalMass() - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Returns total mass : sum of dry mass and ergol mass.
- getTotalMass() - Method in interface fr.cnes.sirius.patrius.propagation.MassProvider
-
Return the mass of the spacecraft.
- getTotalMass(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.propagation.MassProvider
-
Return the mass of the spacecraft following the order.
- getTotalMass() - Method in class fr.cnes.sirius.patrius.propagation.SimpleMassModel
-
Return the mass of the spacecraft.
- getTotalMass(SpacecraftState) - Method in class fr.cnes.sirius.patrius.propagation.SimpleMassModel
-
Return the mass of the spacecraft following the order.
- getTotalSumSquares() - Method in class fr.cnes.sirius.patrius.math.stat.regression.RegressionResults
-
Returns the sum of squared deviations of the y values about their mean.
- getTotalSumSquares() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the y values about their mean.
- getTotalWeight() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGrid
-
Returns the sum of the weights of all the grid points.
- getTrace() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTrace() - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns the
trace of the matrix
(the sum of the elements on the main diagonal).
- getTrace() - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the
trace of the matrix
(the sum of the elements on the main diagonal).
- getTrace() - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTrace() - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns the
trace of the matrix
(the sum of the elements on the main diagonal).
- getTransform() - Method in class fr.cnes.sirius.patrius.assembly.Part
-
Returns the transform linking the part to its parent part.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(SpacecraftState) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleTransform
-
Get the
Transform corresponding to specified state.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.OrientationTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.attitudes.OrientationTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.OrientationTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.OrientationTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.AbstractVeisProvider
-
Get the transform from GTOD at specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.AbstractVeisProvider
-
Get the transform from GTOD at specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.AbstractVeisProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.AbstractVeisProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.CIRFProvider
-
Get the transform from GCRF to CIRF2000 at the specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.CIRFProvider
-
Get the transform from GCRF to CIRF2000 at the specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.CIRFProvider
-
Get the transform from GCRF to CIRF2000 at the specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.CIRFProvider
-
Get the transform from GCRF to CIRF2000 at the specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.EclipticMODProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.EclipticMODProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.EclipticMODProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.EclipticMODProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.EMBProvider
-
Get the transform from Earth-Moon barycenter frame to Solar System barycenter frame (ICRF) at the specified
date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.EMBProvider
-
Get the transform from Earth-Moon barycenter frame to Solar System barycenter frame (ICRF) at the specified
date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.EMBProvider
-
Get the transform from Earth-Moon barycenter frame to Solar System barycenter frame (ICRF) at the specified
date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.EMBProvider
-
Get the transform from Earth-Moon barycenter frame to Solar System barycenter frame (ICRF) at the specified
date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.FixedTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.FixedTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.FixedTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.FixedTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.GCRFProvider
-
Get the transform from GCRF to Earth-Moon barycenter frame at the specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.GCRFProvider
-
Get the transform from GCRF to Earth-Moon barycenter frame at the specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.GCRFProvider
-
Get the transform from GCRF to Earth-Moon barycenter frame at the specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.GCRFProvider
-
Get the transform from GCRF to Earth-Moon barycenter frame at the specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the transform from TOD at specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the transform from TOD at specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the transform from TOD at specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Get the transform from TOD at specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.HelmertTransformation
-
Compute the transform at some date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.HelmertTransformation
-
Compute the transform at some date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.HelmertTransformation
-
Compute the transform at some date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.HelmertTransformation
-
Compute the transform at some date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.InterpolatingTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.InterpolatingTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.InterpolatingTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.InterpolatingTransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.ITRFEquinoxProvider
-
Get the transform from GTOD at specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.ITRFEquinoxProvider
-
Get the transform from GTOD at specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.ITRFEquinoxProvider
-
Get the transform from GTOD at specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.ITRFEquinoxProvider
-
Get the transform from GTOD at specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.ITRFProvider
-
Get the transform from TIRF 2000 at specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.ITRFProvider
-
Get the transform from TIRF 2000 at specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.ITRFProvider
-
Get the transform from TIRF 2000 at specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.ITRFProvider
-
Get the transform from TIRF 2000 at specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.MODProvider
-
Get the transfrom from parent frame.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.MODProvider
-
Get the transfrom from parent frame.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.MODProvider
-
Get the transfrom from parent frame.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.MODProvider
-
Get the transfrom from parent frame.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.TEMEProvider
-
Get the transform from True Of Date date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.TEMEProvider
-
Get the transform from True Of Date date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.TEMEProvider
-
Get the transform from True Of Date date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.TEMEProvider
-
Get the transform from True Of Date date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.TIRFProvider
-
Get the transform from CIRF 2000 at specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.TIRFProvider
-
Get the transform from CIRF 2000 at specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.TIRFProvider
-
Get the transform from CIRF 2000 at specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.TIRFProvider
-
Get the transform from CIRF 2000 at specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.TODProvider
-
Get the transform from Mean Of Date at specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.TODProvider
-
Get the transform from Mean Of Date at specified date.
- getTransform(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.transformations.TODProvider
-
Get the transform from Mean Of Date at specified date.
- getTransform(AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.TODProvider
-
Get the transform from Mean Of Date at specified date.
- getTransform(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.transformations.TransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration) - Method in interface fr.cnes.sirius.patrius.frames.transformations.TransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, boolean) - Method in interface fr.cnes.sirius.patrius.frames.transformations.TransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in interface fr.cnes.sirius.patrius.frames.transformations.TransformProvider
-
Get the
Transform corresponding to specified date.
- getTransform(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.frames.transformations.TransformStateProvider
-
Get the
Transform corresponding to specified state.
- getTransform(AffineTransform) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Get a
Transform embedding an affine transform.
- getTransformedToTargetDirection() - Method in class fr.cnes.sirius.patrius.attitudes.directions.LightAberrationTransformation
-
Getter for the transformed light path direction towards the target in the new frame F'.
- getTransformer(Class<?>) - Method in class fr.cnes.sirius.patrius.math.util.TransformerMap
-
Returns the Transformer that is mapped to a class
if mapping is not present, this returns null.
- getTransformJacobian(Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Compute the Jacobian from current frame to target frame at provided date.
- getTransformProvider() - Method in class fr.cnes.sirius.patrius.assembly.MobilePart
-
Returns the transform linking the part to its parent part.
- getTransformProvider() - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the provider for transform from parent frame to instance.
- getTransformTo(Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the transform from the instance to another frame.
- getTransformTo(Frame, AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the transform from the instance to another frame.
- getTransformTo(Frame, AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the transform from the instance to another frame.
- getTransformTo(Frame, AbsoluteDate, FramesConfiguration, boolean) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Get the transform from the instance to another frame.
- getTransitionMatrix(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.analytical.J2SecularPropagator
-
Compute transition matrix for given date.
- getTranslation() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the position of the "destination" frame in the "origin" one.
- getTranslation() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Screw
-
- getTransparentDimension() - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Gets this matrix's transparent dimension (i.e. the number of columns of the matrix B).
- getTransversalSurf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularCylinder
-
Get transversal surface.
- getTransversalSurf() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularSurfaceCylinder
-
Get transversal surface (m2).
- getTransverseRadius() - Method in interface fr.cnes.sirius.patrius.bodies.EllipsoidBodyShape
-
- getTransverseRadius() - Method in class fr.cnes.sirius.patrius.bodies.OneAxisEllipsoid
-
- getTransverseRadius() - Method in class fr.cnes.sirius.patrius.bodies.ThreeAxisEllipsoid
-
- getTree(boolean) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Get the underlying BSP tree.
- getTree(boolean) - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Region
-
Get the underlying BSP tree.
- gettRef() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getTriangle() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Intersection
-
Return the intersecting triangle.
- getTriangles() - Method in class fr.cnes.sirius.patrius.bodies.mesh.EllipsoidMeshLoader
-
Returns the list of triangles of the mesh.
- getTriangles() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the mesh under a list of triangles.
- getTriangles() - Method in interface fr.cnes.sirius.patrius.bodies.mesh.MeshProvider
-
Returns the list of triangles of the mesh.
- getTriangles() - Method in class fr.cnes.sirius.patrius.bodies.mesh.ObjMeshLoader
-
Returns the list of triangles of the mesh.
- getTrigger() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get the triggering event.
- getTrigonometricCoefficients() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DParameterModel
-
Returns the trigonometric coefficients array.
- getTrigonometricPolynomial() - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialPrimitive
-
Get the Trigonometric Polynomial Part
- getTrigonometricValue(double, double) - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DParameterModel
-
Get the value of the trigonometric contribution with maximum order.
- getTrigonometricValue(double, double, int) - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DParameterModel
-
Get the value of the trigonometric contribution up to provided order.
- getTrueAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the true anomaly.
- getTrueAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the true anomaly.
- getTrueAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.EquatorialParameters
-
Get the true anomaly.
- getTrueAnomaly() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Get the true anomaly.
- getTSurfaceFromRadiusAndLength(double, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightCircularSurfaceCylinder
-
Get transversal surface from radius and length.
- getTT() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the Terrestrial Time scale.
- getTwo() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Get the constant 2.
- getTwo() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant 2.
- getType() - Method in interface fr.cnes.sirius.patrius.assembly.IPartProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAltitude
-
Returns type of aerodynamic coefficient.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAoA
-
Returns type of aerodynamic coefficient.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAoAAndMach
-
Returns type of aerodynamic coefficient.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByMach
-
Returns type of aerodynamic coefficient.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffConstant
-
Returns type of aerodynamic coefficient.
- getType() - Method in interface fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AerodynamicCoefficient
-
Returns type of aerodynamic coefficient.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroApplicationPoint
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroCrossSectionProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.CrossSectionProviderProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.GeometricProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.MassProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.PropulsiveProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeApplicationPoint
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeCrossSectionProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeFacetProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeSphereProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.TankProperty
-
Get the type of the property.
- getType() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceKernelInfo
-
Getter for the file type.
- getType() - Method in class fr.cnes.sirius.patrius.bodies.IAUPoleFunction
-
Returns the IAU pole type.
- getType() - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
- getType() - Method in class fr.cnes.sirius.patrius.orbits.AlternateEquinoctialOrbit
-
Get the orbit type.
- getType() - Method in class fr.cnes.sirius.patrius.orbits.ApsisOrbit
-
Get the orbit type.
- getType() - Method in class fr.cnes.sirius.patrius.orbits.CartesianOrbit
-
Get the orbit type.
- getType() - Method in class fr.cnes.sirius.patrius.orbits.CircularOrbit
-
Get the orbit type.
- getType() - Method in class fr.cnes.sirius.patrius.orbits.EquatorialOrbit
-
Get the orbit type.
- getType() - Method in class fr.cnes.sirius.patrius.orbits.EquinoctialOrbit
-
Get the orbit type.
- getType() - Method in class fr.cnes.sirius.patrius.orbits.KeplerianOrbit
-
Get the orbit type.
- getType() - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
Get the orbit type.
- getType() - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaGaussContribution
-
- getType() - Method in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaLagrangeContribution
-
- getType() - Method in interface fr.cnes.sirius.patrius.stela.forces.StelaForceModel
-
- getType() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Get the orbit type.
- getU() - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
-
Get the U axis
- getU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractEllipse
-
- getU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCone
-
- getU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCylinder
-
- getU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCone
-
- getU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCylinder
-
- getU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
- getU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Get the plane first canonical vector.
- getU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getU() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RectangleCone
-
- getU() - Method in class fr.cnes.sirius.patrius.math.linear.FieldLUDecomposition
-
Returns the matrix U of the decomposition.
- getU() - Method in class fr.cnes.sirius.patrius.math.linear.LUDecomposition
-
Returns the matrix U of the decomposition.
- getU() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Returns the matrix U of the decomposition.
- getU() - Method in interface fr.cnes.sirius.patrius.math.linear.UDDecomposition
-
Returns the matrix U of the decomposition.
- getU() - Method in class fr.cnes.sirius.patrius.math.linear.UDDecompositionImpl
-
Get the U matrix
- getUb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the upper bounds
- getUb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Get the upper bounds
- getUb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Return the upper bounds for the problem.
- getUnboundedLBValue() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the unbounded lower bound value
- getUnboundedUBValue() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPStandardConverter
-
Get the unbounded upper bound value
- getUnderlyingAttitudeLaw() - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointingWrapper
-
Get the underlying (ground pointing) attitude provider.
- getUnderlyingAttitudeLaw() - Method in interface fr.cnes.sirius.patrius.attitudes.AttitudeLawModifier
-
Get the underlying attitude law.
- getUnderlyingAttitudeLaw() - Method in class fr.cnes.sirius.patrius.attitudes.ComposedAttitudeLaw
-
Get the underlying attitude law.
- getUnderlyingAttitudeLaw() - Method in class fr.cnes.sirius.patrius.attitudes.SpinStabilized
-
Get the underlying attitude law.
- getUnionWith(PyramidalField) - Method in class fr.cnes.sirius.patrius.fieldsofview.PyramidalField
-
Build a new
PyramidalField from the union between this field of view and the provided one.
- getUniqueCount() - Method in class fr.cnes.sirius.patrius.math.stat.Frequency
-
Returns the number of values in the frequency table.
- getUpper() - Method in class fr.cnes.sirius.patrius.math.optim.SimpleBounds
-
Gets the upper bounds.
- getUpperAngle() - Method in class fr.cnes.sirius.patrius.math.interval.AngleInterval
-
- getUpperBound() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Getter for the upper bound of the re-use interval.
- getUpperBound() - Method in class fr.cnes.sirius.patrius.math.optim.BaseMultivariateOptimizer
-
- getUpperBounds() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Returns a fresh copy of the array of upper bounds for the bins.
- getUpperCaseAbbreviation() - Method in enum fr.cnes.sirius.patrius.time.Month
-
Get the upper case three letters abbreviation.
- getUpperCaseName() - Method in enum fr.cnes.sirius.patrius.time.Month
-
Get the upper case full name.
- getUpperData() - Method in class fr.cnes.sirius.patrius.math.interval.GenericInterval
-
- getUpperEndPoint() - Method in class fr.cnes.sirius.patrius.math.interval.AbstractInterval
-
- getUpperEndpoint() - Method in class fr.cnes.sirius.patrius.math.interval.GenericInterval
-
- getUranus() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Uranus singleton body.
- getUsedDV() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Get the maneuver instantaneous consumption deltaV.
- getUsedDV() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
Get the maneuver instantaneous consumption deltaV.
- getUT() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Returns the transpose of the matrix U of the decomposition.
- getUT() - Method in interface fr.cnes.sirius.patrius.math.linear.UDDecomposition
-
Returns the transpose of the matrix U of the decomposition.
- getUT() - Method in class fr.cnes.sirius.patrius.math.linear.UDDecompositionImpl
-
get the UT matrix
- getUT1() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the Universal Time 1 scale.
- getUT1Correction(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.DiurnalRotation
-
Compute ut1-tai correction.
- getUT1Correction(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Compute correction dut1.
- getUT1Correction(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Compute correction dut1.
- getUT1Correction(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.libration.IERS2010LibrationCorrection
-
Get the dUT1 value.
- getUT1Correction(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.libration.LibrationCorrectionModel
-
Compute the UT1-TAI corrections at a given date.
- getUT1Correction(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.libration.LibrationCorrectionPerThread
-
Compute the UT1-TAI corrections at a given date.
- getUT1Correction(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.libration.NoLibrationCorrection
-
Compute the UT1-TAI corrections at a given date.
- getUT1Correction(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.IERS2003TidalCorrection
-
Compute the UT1-TAI corrections at a given date.
- getUT1Correction(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.IERS2010TidalCorrection
-
Compute the UT1-TAI corrections at a given date.
- getUT1Correction(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.NoTidalCorrection
-
Compute the UT1-TAI corrections at a given date.
- getUT1Correction() - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrection
-
Returns the UT1-TAI correction.
- getUT1Correction(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrectionModel
-
Compute the UT1-TAI corrections at a given date.
- getUT1Correction(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.tides.TidalCorrectionPerThread
-
Compute the UT1-TAI corrections at a given date.
- getUT1MinusTAI(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Get the UT1-TAI value.
- getUT1MinusTAI(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
-
Get the UT1-TAI value.
- getUT1MinusTAI() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPEntry
-
Get the UT1-TAI value.
- getUT1MinusTAI(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistory
-
Get the UT1-TAI value.
- getUT1MinusTAI(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NoEOP2000History
-
getUT1MinusTAI.
- getUT1MinusTAI(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.FramesConfiguration
-
Compute corrected ut1-tai.
- getUT1MinusTAI(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Compute corrected ut1-tai.
- getUT1MinusTAI(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.AbstractVeisProvider
-
Returns UT1 - TAI value.
- getUT1MinusTAI(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.G50Provider
-
Returns UT1 - TAI value.
- getUT1MinusTAI(AbsoluteDate, FramesConfiguration) - Method in class fr.cnes.sirius.patrius.frames.transformations.VEISProvider
-
Returns UT1 - TAI value.
- getUT1MinusUTC(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Get the UT1-UTC value.
- getUT1MinusUTC(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
-
Get the UT1-UTC value.
- getUT1MinusUTC(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistory
-
Get the UT1-UTC value.
- getUTC() - Static method in class fr.cnes.sirius.patrius.time.TimeScalesFactory
-
Get the Universal Time Coordinate scale.
- getV() - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
-
Get the V axis
- getV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractEllipse
-
- getV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCone
-
- getV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.EllipticCylinder
-
- getV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCone
-
- getV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCylinder
-
- getV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
- getV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Get the plane second canonical vector.
- getV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getV() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RectangleCone
-
- getV() - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Gets the matrix V of the decomposition.
- getV() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Returns the matrix V of the decomposition.
- getValidityDuration() - Method in class fr.cnes.sirius.patrius.bodies.PosVelChebyshev
-
Get model validity duration.
- getValue() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Get the value part of the derivative structure.
- getValue(String) - Method in class fr.cnes.sirius.patrius.math.exception.util.ExceptionContext
-
Gets the value associated to the given context key.
- getValue() - Method in class fr.cnes.sirius.patrius.math.linear.RealVector.Entry
-
Get the value of the entry.
- getValue() - Method in class fr.cnes.sirius.patrius.math.optim.linear.LinearConstraint
-
Gets the value of the constraint (right hand side).
- getValue() - Method in class fr.cnes.sirius.patrius.math.optim.PointVectorValuePair
-
Getter for the value of the objective function.
- getValue() - Method in class fr.cnes.sirius.patrius.math.optim.univariate.UnivariatePointValuePair
-
Get the value of the objective function.
- getValue() - Method in class fr.cnes.sirius.patrius.math.parameter.Parameter
-
Gets the parameter value.
- getValue() - Method in class fr.cnes.sirius.patrius.math.util.Pair
-
Getter for the value.
- getValue(AbsoluteDate, double, double) - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DParameterModel
-
Get the value of the model at provided date.
- getValue(AbsoluteDate, double, double, int) - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DParameterModel
-
Get the value of the model at provided date.
- getValue() - Method in class fr.cnes.sirius.patrius.tools.cache.CacheEntry
-
Getter for the value of the entry.
- getValueRef() - Method in class fr.cnes.sirius.patrius.math.optim.PointVectorValuePair
-
Gets a reference to the value of the objective function.
- getValues() - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.BiLinearIntervalsFunction
-
Gets ftab in dimension 2
- getValues() - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.TriLinearIntervalsFunction
-
Gets ftab in dimension 3
- getValues() - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.UniLinearIntervalsFunction
-
Getter for ftab in dimension 1
- getValues() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the current set of values in an array of double primitives.
- getValues() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the current set of values in an array of double primitives.
- getValuesFileURL() - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
- getValuesSamples() - Method in class fr.cnes.sirius.patrius.models.earth.InterpolationTableLoader
-
Returns a copy of the values samples for the interpolation function.
- getVariablePotentialProvider() - Static method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariableGravityFieldFactory
-
Get the variable gravity field coefficients provider from the first supported file.
- getVariance(int) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the variance σi = Ci,i for the specified
row/column index.
- getVariance(ParameterDescriptor) - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the variance σi = Ci,i associated with the
specified parameter descriptor.
- getVariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AggregateSummaryStatistics
-
Returns the variance of the available values.
- getVariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the (sample) variance of the available values.
- getVariance() - Method in interface fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummary
-
Returns the variance of the available values.
- getVariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummaryValues
-
- getVariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the (sample) variance of the available values.
- getVariance() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the (sample) variance of the available values.
- getVarianceDirection() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Returns the varianceDirection property.
- getVarianceImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the currently configured variance implementation.
- getVarianceImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Returns the currently configured variance implementation
- getVarianceImpl() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Returns the currently configured variance implementation
- getVarianceMatrix() - Method in class fr.cnes.sirius.patrius.covariance.Covariance
-
Gets the variance matrix.
- getVarName() - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.Watcher
-
Getter for the variable name of the watcher.
- getVecAbsoluteTolerance() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Returns the vector of absolute tolerances.
- getVecRelativeTolerance() - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Returns the vector of relative tolerances.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.CelestialBodyPolesAxisDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.ConstantVectorDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.CrossProductDirection
-
Provides the cross product of direction1 vector and dirction2 vector.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthCenterDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthToCelestialPointDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, ITargetDirection.SignalDirection, ITargetDirection.AberrationCorrection, AbsoluteDate, VacuumSignalPropagationModel.FixedDate, Frame, double) - Method in class fr.cnes.sirius.patrius.attitudes.directions.EarthToCelestialPointDirection
-
Provides the direction vector (from origin to target) at entered date, taking into account the type of date
(emission or reception), corrected for light-time and stellar aberration pending the entered correction
parameter.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GenericTargetDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GlintApproximatePointingDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.GroundVelocityDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in interface fr.cnes.sirius.patrius.attitudes.directions.IDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, ITargetDirection.SignalDirection, ITargetDirection.AberrationCorrection, AbsoluteDate, VacuumSignalPropagationModel.FixedDate, Frame, double) - Method in interface fr.cnes.sirius.patrius.attitudes.directions.ITargetDirection
-
Provides the direction vector (from origin to target) at entered date, taking into account the type of date
(emission or reception), corrected for light-time and stellar aberration pending the entered correction
parameter.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.MomentumDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.NadirDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.NorthNormalToEclipticDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.ToCelestialPointDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.directions.VelocityDirection
-
Provides the direction vector at a given date in a given frame.
- getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.bodies.BasicBoardSun
-
Get the direction of the sun.
- getVector(Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
- getVector() - Method in class fr.cnes.sirius.patrius.signalpropagation.VacuumSignalPropagation
-
Getter for the propagation vector in the reference frame.
- getVector3D(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractVector3DFunction
-
Get the vector at a given date.
- getVector3D(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3DFunction
-
Get the vector at a given date.
- getVectorialLocalExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Express a Vector3D in ellipsoid local basis.
- getVectorialLocalExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
Express a Vector3D in spheroid local frame.
- getVectorialLocalExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
Express a Vector3D in spheroid local frame.
- getVectorialStandardExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Express a Vector3D in standard basis.
- getVectorialStandardExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCone
-
Express a Vector3D in standard basis.
- getVectorialStandardExpression(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteEllipticCylinder
-
Express a Vector3D in standard basis.
- getVectorPart() - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Gets the three components of the vector part of the quaternion.
- getVectorS() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
-
- getVehicle() - Method in class fr.cnes.sirius.patrius.events.detectors.ExtremaSightAxisDetector
-
Get the vehicle.
- getVehicleSurfaceModel() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.AerodynamicProperties
-
Get the surface model.
- getVehicleSurfaceModel() - Method in class fr.cnes.sirius.patrius.assembly.vehicle.RadiativeProperties
-
Get vehicle surface model.
- getVeis1950() - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Get the VEIS 1950 reference frame.
- getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Getter for the inertial velocity of atmosphere molecules.
- getVelocity(AbsoluteDate, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.Atmosphere
-
Get the spacecraft velocity relative to the atmosphere.
- getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.HarrisPriester
-
Getter for the inertial velocity of atmosphere molecules.
- getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.JB2006
-
Get the inertial velocity of atmosphere molecules.
- getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSISE2000
-
Get the spacecraft velocity relative to the atmosphere.
- getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
Get the spacecraft velocity relative to the atmosphere.
- getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.US76
-
Get the spacecraft velocity relative to the atmosphere.
- getVelocity() - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get the velocity of the "destination" frame in the "origin" one.
- getVelocity() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.CartesianParameters
-
Get the velocity.
- getVelocity() - Method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.ReentryParameters
-
Getter for the velocity.
- getVelocity() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Gets the velocity.
- getVelocity() - Method in interface fr.cnes.sirius.patrius.orbits.pvcoordinates.PV
-
Gets the velocity.
- getVelocity() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.PVCoordinates
-
Gets the velocity.
- getVelocity() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.TopocentricPV
-
Gets the velocity.
- getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.Jacchia77
-
Get the spacecraft velocity relative to the atmosphere.
- getVelocity() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaDragCoefInput
-
Getter for the relative velocity of the spacecraft with respect to the atmosphere.
- getVenus() - Static method in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Get the Venus singleton body.
- getVenusThirdBodyAttraction() - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- getVerticalLeftSeparator() - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Getter for the String representing the vertical separator of the left column.
- getVerticalRightSeparator() - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Getter for the String representing the vertical separator of the right column.
- getVerticalSeparator() - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Getter for the String representing the vertical separator of the middle columns.
- getVertices() - Method in class fr.cnes.sirius.patrius.bodies.mesh.EllipsoidMeshLoader
-
Returns the list of vertices of the mesh.
- getVertices() - Method in interface fr.cnes.sirius.patrius.bodies.mesh.MeshProvider
-
Returns the list of vertices of the mesh.
- getVertices() - Method in class fr.cnes.sirius.patrius.bodies.mesh.ObjMeshLoader
-
Returns the list of vertices of the mesh.
- getVertices() - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Getter for the triangle vertices.
- getVertices() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.PolyhedronsSet.BRep
-
Get the extracted vertices.
- getVertices() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
Get the vertices of the polygon.
- getVisibleAndEnlightenedTriangles(List<SpacecraftState>, PVCoordinatesProvider, IFieldOfView) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Getter for the list of triangles enlightened (by the Sun) and visible at least once during the whole ephemeris
from
the satellite field of view.
- getVisibleSurface() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FieldData
-
Getter for the visible surface.
- getVisibleTriangles() - Method in class fr.cnes.sirius.patrius.bodies.mesh.FieldData
-
Getter for the list of visible triangles.
- getVT() - Method in class fr.cnes.sirius.patrius.math.linear.EigenDecomposition
-
Gets the transpose of the matrix V of the decomposition.
- getVT() - Method in class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Returns the transpose of the matrix V of the decomposition.
- getW() - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
-
Get the W axis.
- getW() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
- getW() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
- getWallGasTemperature(SpacecraftState, Vector3D, double) - Method in class fr.cnes.sirius.patrius.assembly.models.cook.ConstantWallGasTemperature
-
Compute wall gas temperature.
- getWallGasTemperature(SpacecraftState, Vector3D, double) - Method in class fr.cnes.sirius.patrius.assembly.models.cook.CookWallGasTemperature
-
Compute wall gas temperature.
- getWallGasTemperature(SpacecraftState, Vector3D, double) - Method in class fr.cnes.sirius.patrius.assembly.models.cook.GinsWallGasTemperature
-
Compute wall gas temperature.
- getWallGasTemperature(SpacecraftState, Vector3D, double) - Method in interface fr.cnes.sirius.patrius.assembly.models.cook.WallGasTemperatureProvider
-
Compute wall gas temperature.
- getWallTemperature() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroProperty
-
Getter for the wall temperature.
- getWavelengthNanometer() - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Getter for the wavelength [nanometer].
- getWCoeffs() - Method in class fr.cnes.sirius.patrius.bodies.IAUPoleCoefficients
-
Returns the coefficients for W component.
- getWeekNumber() - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Returns the week number (corresponding to a GPS date).
- getWeight() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGridPoint
-
Gets the weight associated to the point for Lebedev's rule.
- getWeight() - Method in class fr.cnes.sirius.patrius.math.fitting.WeightedObservedPoint
-
Gets the weight of the measurement in the fitting process.
- getWeight() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.MultivariateVectorOptimizer
-
Gets the weight matrix of the observations.
- getWeight() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.Weight
-
Gets the initial guess.
- getWeight() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.AbstractTLEFitter
-
Get the weights for residuals.
- getWeightSquareRoot() - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
-
Gets the square-root of the weight matrix.
- getWest() - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the west direction of topocentric frame, expressed in the body frame of body shape to which the frame
center point is attached.
- getWholeFormat() - Method in class fr.cnes.sirius.patrius.math.fraction.ProperBigFractionFormat
-
Access the whole format.
- getWholeFormat() - Method in class fr.cnes.sirius.patrius.math.fraction.ProperFractionFormat
-
Access the whole format.
- getWidth() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.InfiniteRectangleCylinder
-
- getWidth() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Parallelepiped
-
- getWidth() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plate
-
- getWidth() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RectangleCone
-
- getWidth() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Get y direction dimension (m).
- getWidthFromSurfs(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.RightParallelepiped
-
Get parallelepiped width (Y direction dimension).
- getWindowSize() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Returns the maximum number of values that can be stored in the
dataset, or INFINITE_WINDOW (-1) if there is no limit.
- getWindowSize() - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Returns the maximum number of values that can be stored in the
dataset, or INFINITE_WINDOW (-1) if there is no limit.
- getWMM(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticFieldFactory
-
Get the WMM model for the given year.
- getWMM(double) - Static method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticFieldFactory
-
Get the WMM model for the given year.
- getWrappedDetector() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Returns the underlying wrapped detector.
- getWrench() - Method in class fr.cnes.sirius.patrius.wrenches.Wrench
-
Get a double[] representation of this wrench.
- getWrongColumnDimension() - Method in exception fr.cnes.sirius.patrius.math.linear.MatrixDimensionMismatchException
-
- getWrongDimension(int) - Method in exception fr.cnes.sirius.patrius.math.exception.MultiDimensionMismatchException
-
- getWrongDimensions() - Method in exception fr.cnes.sirius.patrius.math.exception.MultiDimensionMismatchException
-
- getWrongRowDimension() - Method in exception fr.cnes.sirius.patrius.math.linear.MatrixDimensionMismatchException
-
- getX() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPEntry
-
Get the X component of the pole motion.
- getX() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Getter for the x-coordinate of pole.
- getX() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGridPoint
-
Gets the coordinate of the point on the 1st axis.
- getX() - Method in class fr.cnes.sirius.patrius.math.fitting.WeightedObservedPoint
-
Gets the abscissa of the point.
- getX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Get the abscissa of the vector.
- getX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Get the abscissa of the vector.
- getX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the abscissa of the vector.
- getX() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Get the abscissa of the vector.
- getX() - Method in class fr.cnes.sirius.patrius.math.stat.regression.AbstractMultipleLinearRegression
-
- getX0() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.DateIntervalLinearFunction
-
Returns value at first date.
- getX0() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.DateIntervalParabolicFunction
-
Returns value at first date.
- getXangle() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPosition
-
Get the x angle.
- getXangle() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Get the angle of the rotation around the local North axis.
- getXangleCardan(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the Cardan x angle of a point.
- getXangleCardanRate(PVCoordinates, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the Cardan x angle rate.
- getXangleRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Get the angle rate of the rotation around the North axis.
- getXArray() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AbstractAeroCoeff1D
-
Getter for the x variable array of values used for the function definition.
- getXArray() - Method in interface fr.cnes.sirius.patrius.forces.gravity.grid.GridSystem
-
Returns first abscissa data array.
- getXCoefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
- getXCoefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfileLeg
-
Gets the coefficients of the polynomial function representing x angular rate.
- getxDot0() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.DateIntervalParabolicFunction
-
Returns first derivative value at first date.
- getxDotDotIntervals() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.DateIntervalParabolicFunction
-
Returns a copy of 1st order derivatives on date intervals.
- getxDotIntervals() - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.DateIntervalLinearFunction
-
Returns a copy of 1st order derivatives on date intervals.
- getXM10(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
Get the MG2 index scaled to F10.
- getXM10B(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.forces.atmospheres.JB2006InputParameters
-
Get the MG2 81-day average centered index.
- getXMax() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.bivariate.BivariateIntegrator
-
Returns the upper bounds on x used during the last call to this
integrator.
- getXMax() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Returns the upper bounds on x used during the last call to this
integrator.
- getXMin() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.bivariate.BivariateIntegrator
-
Returns the lower bounds on x used during the last call to this
integrator.
- getXMin() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Returns the lower bounds on x used during the last call to this
integrator.
- getXp() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.PoleCorrection
-
Get the xp parameter.
- getxP() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Getter for the x-coordinate derivative of pole.
- getXSumSquares() - Method in class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the x values about their mean.
- getxtab() - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.AbstractLinearIntervalsFunction
-
Gets xtab
- getXYZ() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGridPoint
-
Gets the Cartesian coordinates of the point.
- getY() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPEntry
-
Get the Y component of the pole motion.
- getY() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Getter for the y-coordinate of pole.
- getY() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGridPoint
-
Gets the coordinate of the point on the 2nd axis.
- getY() - Method in class fr.cnes.sirius.patrius.math.fitting.WeightedObservedPoint
-
Gets the observed value of the function at x.
- getY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Get the ordinate of the vector.
- getY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the ordinate of the vector.
- getY() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Get the ordinate of the vector.
- getY() - Method in class fr.cnes.sirius.patrius.math.stat.regression.AbstractMultipleLinearRegression
-
- getYangle() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPosition
-
Get the y angle.
- getYangle() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Get the angle of the rotation around y' axis.
- getYangleCardan(Vector3D, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the Cardan y angle of a point with regards to the projection point on the plane defined by the zenith
and the west axis.
- getYangleCardanRate(PVCoordinates, Frame, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the Cardan y angle rate.
- getYangleRate() - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.CardanMountPV
-
Get the angle rate of the rotation around y' axis (which is the image of the West axis by the first
rotation around the North axis).
- getYArray() - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AbstractAeroCoeff1D
-
Getter for the y variable array of values used for the function definition.
- getYArray() - Method in interface fr.cnes.sirius.patrius.forces.gravity.grid.GridSystem
-
Returns second abscissa data array.
- getYawAngle(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.attitudes.YawCompensation
-
Compute the yaw compensation angle at date.
- getYCoefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
- getYCoefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfileLeg
-
Gets the coefficients of the polynomial function representing y angular rate.
- getYear() - Method in class fr.cnes.sirius.patrius.time.DateComponents
-
Get the year number.
- getYlb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the Lagrangian lower bounds for linear constraints (A rows)
- getYlb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Get the Lagrangian lower bounds for linear constraints (A rows)
- getYMax() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.bivariate.BivariateIntegrator
-
Returns the upper bounds on y used during the last call to this
integrator.
- getYMax() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Returns the upper bounds on y used during the last call to this
integrator.
- getYMin() - Method in interface fr.cnes.sirius.patrius.math.analysis.integration.bivariate.BivariateIntegrator
-
Returns the lower bounds on y used during the last call to this
integrator.
- getYMin() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Returns the lower bounds on y used during the last call to this
integrator.
- getYp() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.PoleCorrection
-
Get the yp parameter.
- getyP() - Method in class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.CIPCoordinates
-
Getter for the y-coordinate derivative of pole.
- getytab() - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.BiLinearIntervalsFunction
-
Gets ytab
- getytab() - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.TriLinearIntervalsFunction
-
Gets ytab
- getYub() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the Lagrangian upper bounds for linear constraints (A rows)
- getYub() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Get the Lagrangian upper bounds for linear constraints (A rows)
- getZ() - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevGridPoint
-
Gets the coordinate of the point on the 3rd axis.
- getZ() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Get the height of the vector.
- getZ() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the height of the vector.
- getZArray() - Method in interface fr.cnes.sirius.patrius.forces.gravity.grid.GridSystem
-
Returns third abscissa data array.
- getZCoefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
- getZCoefficients() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfileLeg
-
Gets the coefficients of the polynomial function representing z angular rate.
- getZenith() - Method in class fr.cnes.sirius.patrius.frames.TopocentricFrame
-
Getter for the zenith direction of topocentric frame, expressed in the body frame of body shape to which the
frame center point is attached.
- getZero() - Method in class fr.cnes.sirius.patrius.math.complex.ComplexField
-
Get the additive identity of the field.
- getZero() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Get the constant 0.
- getZero() - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Get the constant 0.
- getZero() - Method in interface fr.cnes.sirius.patrius.math.Field
-
Get the additive identity of the field.
- getZero() - Method in class fr.cnes.sirius.patrius.math.fraction.BigFractionField
-
Get the additive identity of the field.
- getZero() - Method in class fr.cnes.sirius.patrius.math.fraction.FractionField
-
Get the additive identity of the field.
- getZero() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in class fr.cnes.sirius.patrius.math.util.BigRealField
-
Get the additive identity of the field.
- getZero() - Method in class fr.cnes.sirius.patrius.math.util.Decimal64Field
-
Get the additive identity of the field.
- getZeroDate() - Method in class fr.cnes.sirius.patrius.attitudes.kinematics.AbstractOrientationFunction
-
Get the date at x = 0.
- getZeroDate() - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.AbstractVector3DFunction
-
Get the date at x = 0.
- getZlb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the Lagrangian upper bounds for linear bounds
- getZlb() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Get the Lagrangian upper bounds for linear bounds
- getZonalDegreeMaxPerturbation() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.AbstractStelaZonalAttraction
-
Getter for the degree of development for zonal perturbations.
- getztab() - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.TriLinearIntervalsFunction
-
Gets ztab
- getZub() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Get the Lagrangian upper bounds for upper bounds
- getZub() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Get the Lagrangian upper bounds for upper bounds
- gFunction(double[], double[], int, int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Computation of function G.
- gFunction(double[], double[], int, int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.DTM2000
-
Computation of function G.
- gFunction(double[], double[], int, int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.DTM2012
-
Computation of function G.
- GillIntegrator - Class in fr.cnes.sirius.patrius.math.ode.nonstiff
-
This class implements the Gill fourth order Runge-Kutta
integrator for Ordinary Differential Equations .
- GillIntegrator(double) - Constructor for class fr.cnes.sirius.patrius.math.ode.nonstiff.GillIntegrator
-
Simple constructor.
- GinsWallGasTemperature - Class in fr.cnes.sirius.patrius.assembly.models.cook
-
Wall gas temperature following Cook model adapted to GINS.
- GinsWallGasTemperature(ExtendedAtmosphere, AlphaProvider, double) - Constructor for class fr.cnes.sirius.patrius.assembly.models.cook.GinsWallGasTemperature
-
Constructor.
- GlintApproximatePointingDirection - Class in fr.cnes.sirius.patrius.attitudes.directions
-
"Glint" direction pointing.
- GlintApproximatePointingDirection(OneAxisEllipsoid, PVCoordinatesProvider, UnivariateSolver) - Constructor for class fr.cnes.sirius.patrius.attitudes.directions.GlintApproximatePointingDirection
-
Constructor.
- GlintApproximatePointingDirection(OneAxisEllipsoid, PVCoordinatesProvider) - Constructor for class fr.cnes.sirius.patrius.attitudes.directions.GlintApproximatePointingDirection
-
- GlobalAeroModel - Class in fr.cnes.sirius.patrius.assembly.models
-
Global aero model for generic user-provided aero coefficients.
- GlobalAeroModel(Assembly, DragCoefficientProvider, ExtendedAtmosphere, double) - Constructor for class fr.cnes.sirius.patrius.assembly.models.GlobalAeroModel
-
Constructor.
- GlobalAeroModel(Assembly, DragCoefficientProvider, ExtendedAtmosphere) - Constructor for class fr.cnes.sirius.patrius.assembly.models.GlobalAeroModel
-
- GlobalDragCoefficientProvider - Class in fr.cnes.sirius.patrius.assembly.models
-
- GlobalDragCoefficientProvider(GlobalDragCoefficientProvider.INTERP, String) - Constructor for class fr.cnes.sirius.patrius.assembly.models.GlobalDragCoefficientProvider
-
Constructor.
- GlobalDragCoefficientProvider.INTERP - Enum in fr.cnes.sirius.patrius.assembly.models
-
Enumerate to choose the way to interpolate.
- GLSMultipleLinearRegression - Class in fr.cnes.sirius.patrius.math.stat.regression
-
The GLS implementation of the multiple linear regression.
- GLSMultipleLinearRegression() - Constructor for class fr.cnes.sirius.patrius.math.stat.regression.GLSMultipleLinearRegression
-
- GMSTScale - Class in fr.cnes.sirius.patrius.time
-
Greenwich Mean Sidereal Time.
- GNSSParameters - Class in fr.cnes.sirius.patrius.orbits.pvcoordinates
-
This class is a simple container for generic ephemeris description parameters of GNSS satellites
(almanac or broadcast model ephemeris).
- GNSSParameters(GNSSType, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSParameters
-
Creates an instance of a generic GNSS Parameter (for GPS or BeiDou only)
- GNSSPVCoordinates - Class in fr.cnes.sirius.patrius.orbits.pvcoordinates
-
This class implements the PVCoordinatesProvider to compute position velocity of a GPS, Galileo or
BeiDou constellation satellite from its almanac/broadcast model parameters.
- GNSSPVCoordinates(GNSSParameters, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.orbits.pvcoordinates.GNSSPVCoordinates
-
Creates an instance of AlmanacPVCoordinates.
- GNSSType - Enum in fr.cnes.sirius.patrius.orbits.pvcoordinates
-
Enumerate for GNSS satellites type
- goAhead(double, double, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
go one step ahead
- GoalType - Enum in fr.cnes.sirius.patrius.math.optim.nonlinear.scalar
-
Goal type for an optimization problem (minimization or maximization of
a scalar function.
- GPS_EPOCH - Static variable in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Reference epoch for GPS weeks: 1980-01-06T00:00:00 GPS time.
- GPS_EPOCH - Static variable in class fr.cnes.sirius.patrius.time.DateComponents
-
Reference epoch for GPS weeks: 1980-01-06.
- GPSScale - Class in fr.cnes.sirius.patrius.time
-
GPS time scale.
- gradFiStepX(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Computes the term Grad[fi].stepX
- gradient(double, double...) - Method in class fr.cnes.sirius.patrius.math.analysis.function.Gaussian.Parametric
-
Computes the value of the gradient at x.
- gradient(double, double...) - Method in class fr.cnes.sirius.patrius.math.analysis.function.HarmonicOscillator.Parametric
-
Computes the value of the gradient at x.
- gradient(double, double...) - Method in class fr.cnes.sirius.patrius.math.analysis.function.Logistic.Parametric
-
Computes the value of the gradient at x.
- gradient(double, double...) - Method in class fr.cnes.sirius.patrius.math.analysis.function.Logit.Parametric
-
Computes the value of the gradient at x.
- gradient(double, double...) - Method in class fr.cnes.sirius.patrius.math.analysis.function.Sigmoid.Parametric
-
Computes the value of the gradient at x.
- gradient(double, double...) - Method in interface fr.cnes.sirius.patrius.math.analysis.ParametricUnivariateFunction
-
Compute the gradient of the function with respect to its parameters.
- gradient(double, double...) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialChebyshevFunction
-
Compute the gradient of the function with respect to its parameters.
- gradient(double, double...) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunction.Parametric
-
Compute the gradient of the function with respect to its parameters.
- gradient(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.functions.LogarithmicBarrier
-
Function gradient at point X
- gradient(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.functions.QuadraticMultivariateRealFunction
-
Function gradient at point X
- gradient(double[]) - Method in interface fr.cnes.sirius.patrius.math.optim.joptimizer.functions.TwiceDifferentiableMultivariateRealFunction
-
Function gradient at point X.
- GradientFunction - Class in fr.cnes.sirius.patrius.math.analysis.differentiation
-
Class representing the gradient of a multivariate function.
- GradientFunction(MultivariateDifferentiableFunction) - Constructor for class fr.cnes.sirius.patrius.math.analysis.differentiation.GradientFunction
-
Simple constructor.
- GradientModel - Interface in fr.cnes.sirius.patrius.forces
-
Interface for gradient model.
- GradientMultivariateOptimizer - Class in fr.cnes.sirius.patrius.math.optim.nonlinear.scalar
-
Base class for implementing optimizers for multivariate scalar
differentiable functions.
- GradientMultivariateOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.GradientMultivariateOptimizer
-
- gradLSum(RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Return the H matrix (that is diagonal).
- gradSum(double, RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Calculates the second term of the first row of (11.55) "Convex Optimization".
- GraggBulirschStoerIntegrator - Class in fr.cnes.sirius.patrius.math.ode.nonstiff
-
This class implements a Gragg-Bulirsch-Stoer integrator for
Ordinary Differential Equations.
- GraggBulirschStoerIntegrator(double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.math.ode.nonstiff.GraggBulirschStoerIntegrator
-
Simple constructor.
- GraggBulirschStoerIntegrator(double, double, double[], double[]) - Constructor for class fr.cnes.sirius.patrius.math.ode.nonstiff.GraggBulirschStoerIntegrator
-
Simple constructor.
- GRAVITATIONAL_CONSTANT - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Gravitational constant (CODATA): 6.67384 × 10-11 m3kg-1s-2.
- GravitationalAttractionWrench - Class in fr.cnes.sirius.patrius.wrenches
-
This class represents a gravitational attraction wrench
- GravitationalAttractionWrench(IInertiaModel, double) - Constructor for class fr.cnes.sirius.patrius.wrenches.GravitationalAttractionWrench
-
Create a wrench model from an inertia model and a gravitational parameter
- GRAVITY_MODEL - Static variable in class fr.cnes.sirius.patrius.math.parameter.StandardFieldDescriptors
-
Field descriptor to associate with a gravitational attraction model.
- GravityFieldFactory - Class in fr.cnes.sirius.patrius.forces.gravity.potential
-
Factory used to read gravity field files in several supported formats.
- GravityModel - Interface in fr.cnes.sirius.patrius.forces.gravity
-
This interface represents a gravitational attraction model.
- GravityToolbox - Class in fr.cnes.sirius.patrius.forces.gravity
-
Toolbox for tides.
- greaterOrEqual(double, double) - Static method in class fr.cnes.sirius.patrius.math.Comparators
-
Tests if a double is greater or equal to another with a relative comparison using a default epsilon.
- greaterOrEqual(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.Comparators
-
Tests if a double is greater or equal to another with a relative comparison using an input epsilon.
- greaterOrEqual(double, double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.math.interval.AngleTools
-
Tests if one angle is greater or equal to another after expressing them in the same interval.
- greaterStrict(double, double) - Static method in class fr.cnes.sirius.patrius.math.Comparators
-
Tests if a double is strictly greater than another with a relative comparison using a default epsilon.
- greaterStrict(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.Comparators
-
Tests if a double is strictly greater than another with a relative comparison using an input epsilon.
- greaterStrict(double, double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.math.interval.AngleTools
-
Tests if one angle is strictly greater than another after expressing them in the same interval.
- greaterThan(Dfp) - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Check if instance is greater than x.
- GRGS_FILENAME - Static variable in class fr.cnes.sirius.patrius.forces.gravity.potential.GravityFieldFactory
-
Default regular expression for GRGS files.
- GRGSFormatReader - Class in fr.cnes.sirius.patrius.forces.gravity.potential
-
Reader for the GRGS gravity field format.
- GRGSFormatReader(String, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.potential.GRGSFormatReader
-
Simple constructor.
- GRGSFormatReader(String, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.potential.GRGSFormatReader
-
Simple constructor.
- GRGSRL02_FILENAME - Static variable in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariableGravityFieldFactory
-
EIGEN GRGS default filename
- GRGSRL02FormatReader - Class in fr.cnes.sirius.patrius.forces.gravity.variations.coefficients
-
Reader for the GRGS RL02 gravity field format.
- GRGSRL02FormatReader(String) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.GRGSRL02FormatReader
-
Simple constructor.
- GridAttractionProvider - Interface in fr.cnes.sirius.patrius.forces.gravity.grid
-
Generic grid attraction provider.
- GridGravityModel - Class in fr.cnes.sirius.patrius.forces.gravity.grid
-
Computation of central body attraction with a grid attraction model: attraction acceleration is given by
GridAttractionProvider which provides for a set of coordinates the value of acceleration.
- GridGravityModel(GridAttractionProvider, TrivariateGridInterpolator, GravityModel, Frame) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.grid.GridGravityModel
-
Constructor.
- GridSystem - Interface in fr.cnes.sirius.patrius.forces.gravity.grid
-
Grid system.
- GRIM5C1_EARTH_ANGULAR_VELOCITY - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth angular velocity from GRIM5C1 model: 7.292115e-5 rad/s.
- GRIM5C1_EARTH_C20 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth un-normalized second zonal coefficient from GRIM5C1 model: -1.082626110612609e-3.
- GRIM5C1_EARTH_C30 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth un-normalized third zonal coefficient from GRIM5C1 model: 2.536150841690056e-6.
- GRIM5C1_EARTH_C40 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth un-normalized fourth zonal coefficient from GRIM5C1 model: 1.61936352497151e-6.
- GRIM5C1_EARTH_C50 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth un-normalized fifth zonal coefficient from GRIM5C1 model: 2.231013736607540e-7.
- GRIM5C1_EARTH_C60 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth un-normalized sixth zonal coefficient from GRIM5C1 model: -5.402895357302363e-7.
- GRIM5C1_EARTH_EQUATORIAL_RADIUS - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth equatorial radius from GRIM5C1 model: 6378136.46 m.
- GRIM5C1_EARTH_FLATTENING - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth flattening from GRIM5C1 model: 1.0 / 298.25765.
- GRIM5C1_EARTH_MU - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth gravitational constant from GRIM5C1 model: 3.986004415 m3/s2.
- GroundMaskElevationDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Finder for satellite azimuth-elevation events with respect to a mask.
- GroundMaskElevationDetector(double[][], TopocentricFrame) - Constructor for class fr.cnes.sirius.patrius.events.detectors.GroundMaskElevationDetector
-
Build a new azimuth-elevation detector.
- GroundMaskElevationDetector(double[][], TopocentricFrame, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.GroundMaskElevationDetector
-
Build a new azimuth-elevation detector.
- GroundMaskElevationDetector(double[][], TopocentricFrame, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.GroundMaskElevationDetector
-
Build a new azimuth-elevation detector.
- GroundMaskElevationDetector(double[][], TopocentricFrame, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.GroundMaskElevationDetector
-
Build a new azimuth-elevation detector.
- GroundMaskElevationDetector(double[][], TopocentricFrame, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.GroundMaskElevationDetector
-
Build a new azimuth-elevation detector.
- GroundVelocityDirection - Class in fr.cnes.sirius.patrius.attitudes.directions
-
Ground velocity direction.
- GroundVelocityDirection(BodyShape, IDirection) - Constructor for class fr.cnes.sirius.patrius.attitudes.directions.GroundVelocityDirection
-
Constructor.
- GRS80_EARTH_ANGULAR_VELOCITY - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth angular velocity from GRS80 model: 7.292115e-5 rad/s.
- GRS80_EARTH_C20 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth un-normalized second zonal coefficient from GRS80 model: -1.08263e-3.
- GRS80_EARTH_EQUATORIAL_RADIUS - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth equatorial radius from GRS80 model: 6378137.0 m.
- GRS80_EARTH_FLATTENING - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth flattening from GRS80 model: 1.0 / 298.257222101.
- GRS80_EARTH_MU - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Earth gravitational constant from GRS80 model: 3.986005e14 m3/s2.
- GSURF - Static variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Gravity acceleration at 120 km altitude.
- gtd7(Input, Flags, Output) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.NRLMSISE00
-
gtd7 : Neutral Atmosphere Empirical Model from the surface to lower exosphere.
- gtd7d(Input, Flags, Output) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.NRLMSISE00
-
gtd7d.
- GTest - Class in fr.cnes.sirius.patrius.math.stat.inference
-
- GTest() - Constructor for class fr.cnes.sirius.patrius.math.stat.inference.GTest
-
- gTest(double[], long[]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.GTest
-
Returns the
observed significance level, or
p-value,
associated with a G-Test for goodness of fit comparing the
observed frequency counts to those in the
expected array.
- gTest(double[], long[], double) - Method in class fr.cnes.sirius.patrius.math.stat.inference.GTest
-
Performs a G-Test (Log-Likelihood Ratio Test) for goodness of fit
evaluating the null hypothesis that the observed counts conform to the
frequency distribution described by the expected counts, with
significance level alpha.
- gTest(double[], long[]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- gTest(double[], long[], double) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- gTestDataSetsComparison(long[], long[]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.GTest
-
Returns the
observed significance level, or
p-value, associated with a G-Value
(Log-Likelihood Ratio) for two sample test comparing bin frequency counts in
observed1 and
observed2.
- gTestDataSetsComparison(long[], long[], double) - Method in class fr.cnes.sirius.patrius.math.stat.inference.GTest
-
Performs a G-Test (Log-Likelihood Ratio Test) comparing two binned data sets.
- gTestDataSetsComparison(long[], long[]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- gTestDataSetsComparison(long[], long[], double) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- gTestIntrinsic(double[], long[]) - Method in class fr.cnes.sirius.patrius.math.stat.inference.GTest
-
Returns the intrinsic (Hardy-Weinberg proportions) p-Value, as described
in p64-69 of McDonald, J.H. 2009.
- gTestIntrinsic(double[], long[]) - Static method in class fr.cnes.sirius.patrius.math.stat.inference.TestUtils
-
- GTODProvider - Class in fr.cnes.sirius.patrius.frames.transformations
-
Greenwich True Of Date Frame, also known as True of Date Rotating frame (TDR)
or Greenwich Rotating Coordinate frame (GCR).
- GTODProvider() - Constructor for class fr.cnes.sirius.patrius.frames.transformations.GTODProvider
-
Simple constructor.
- guess() - Method in class fr.cnes.sirius.patrius.math.fitting.GaussianFitter.ParameterGuesser
-
Gets an estimation of the parameters.
- guess() - Method in class fr.cnes.sirius.patrius.math.fitting.HarmonicFitter.ParameterGuesser
-
Gets an estimation of the parameters.
- GZIP_FILE_PATTERN - Static variable in interface fr.cnes.sirius.patrius.data.DataProvider
-
Pattern for name of gzip files.
- S - Static variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEConstants
-
Potential perturbation coefficient.
- s2h - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Intermediate values.
- s3h - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Intermediate values.
- s4 - Variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
s* new value for the contant s.
- SaastamoinenModel - Class in fr.cnes.sirius.patrius.signalpropagation.troposphere
-
The modified Saastamoinen model.
- SaastamoinenModel(MeteorologicalConditionsProvider, double) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.troposphere.SaastamoinenModel
-
Create a new Saastamoinen model for the troposphere using the given
environmental conditions [T, P, RH] and station altitude.
- SaastamoinenModelFactory - Class in fr.cnes.sirius.patrius.signalpropagation.troposphere
-
- SaastamoinenModelFactory() - Constructor for class fr.cnes.sirius.patrius.signalpropagation.troposphere.SaastamoinenModelFactory
-
- SAFE_MIN - Static variable in class fr.cnes.sirius.patrius.math.util.Precision
-
Safe minimum, such that 1 / SAFE_MIN does not overflow.
- safeNorm(double[]) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Returns the Cartesian norm (2-norm), handling both overflow and underflow.
- sameOrientationAs(Hyperplane<Euclidean1D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.OrientedPoint
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<Euclidean3D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Plane
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<Euclidean2D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<S>) - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Hyperplane
-
Check if the instance has the same orientation as another hyperplane.
- sample(UnivariateFunction, double, double, int) - Static method in class fr.cnes.sirius.patrius.math.analysis.FunctionUtils
-
Samples the specified univariate real function on the specified interval.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractIntegerDistribution
-
Generate a random value sampled from this distribution.
- sample(int) - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractIntegerDistribution
-
Generate a random sample from the distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractMultivariateRealDistribution
-
Generates a random value vector sampled from this distribution.
- sample(int) - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractMultivariateRealDistribution
-
Generates a list of a random value vectors from the distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractRealDistribution
-
Generate a random value sampled from this distribution.
- sample(int) - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractRealDistribution
-
Generate a random sample from the distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.ExponentialDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.GammaDistribution
-
This implementation uses the following algorithms:
For 0 < shape < 1:
Ahrens, J.
- sample() - Method in interface fr.cnes.sirius.patrius.math.distribution.IntegerDistribution
-
Generate a random value sampled from this distribution.
- sample(int) - Method in interface fr.cnes.sirius.patrius.math.distribution.IntegerDistribution
-
Generate a random sample from the distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.LogNormalDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.MixtureMultivariateRealDistribution
-
Generates a random value vector sampled from this distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.MultivariateNormalDistribution
-
Generates a random value vector sampled from this distribution.
- sample() - Method in interface fr.cnes.sirius.patrius.math.distribution.MultivariateRealDistribution
-
Generates a random value vector sampled from this distribution.
- sample(int) - Method in interface fr.cnes.sirius.patrius.math.distribution.MultivariateRealDistribution
-
Generates a list of a random value vectors from the distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.NormalDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.PoissonDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in interface fr.cnes.sirius.patrius.math.distribution.RealDistribution
-
Generate a random value sampled from this distribution.
- sample(int) - Method in interface fr.cnes.sirius.patrius.math.distribution.RealDistribution
-
Generate a random sample from the distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformIntegerDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.distribution.UniformRealDistribution
-
Generate a random value sampled from this distribution.
- sample() - Method in class fr.cnes.sirius.patrius.math.random.EmpiricalDistribution
-
Generate a random value sampled from this distribution.
- sanityChecks(ExpandableStatefulODE, double) - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Check the integration span.
- sanityChecks(ExpandableStatefulODE, double) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Check the integration span.
- SatelliteInformation - Class in fr.cnes.sirius.patrius.files.general
-
Contains general information about a satellite as contained
in an orbit file.
- SatelliteInformation(String) - Constructor for class fr.cnes.sirius.patrius.files.general.SatelliteInformation
-
- SatelliteTimeCoordinate - Class in fr.cnes.sirius.patrius.files.general
-
Contains the position/velocity of a satellite at an specific epoch.
- SatelliteTimeCoordinate(AbsoluteDate, PVCoordinates) - Constructor for class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
- SatelliteTimeCoordinate(AbsoluteDate, Vector3D, double) - Constructor for class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
- SatelliteTimeCoordinate(AbsoluteDate, PVCoordinates, double, double) - Constructor for class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
- SatToSatMutualVisibilityDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Mutual spacecraft visibility detector : the g function is positive only if each spacecraft is in the main field of
view of the other one's sensor.
- SatToSatMutualVisibilityDetector(SensorModel, SensorModel, Propagator, boolean, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Constructor to be used for single spacecraft propagation only (
Propagator).
- SatToSatMutualVisibilityDetector(SensorModel, SensorModel, Propagator, boolean, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Constructor to be used for single spacecraft propagation only (
Propagator).
- SatToSatMutualVisibilityDetector(SensorModel, SensorModel, Propagator, boolean, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Constructor to be used for single spacecraft propagation only (
Propagator).
- SatToSatMutualVisibilityDetector(SensorModel, SensorModel, Propagator, boolean, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean, SatToSatMutualVisibilityDetector.SatToSatLinkType) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Constructor to be used for single spacecraft propagation only (
Propagator).
- SatToSatMutualVisibilityDetector(String, String, SensorModel, SensorModel, boolean, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Constructor to be used for multi spacecraft propagation only (
MultiPropagator).
- SatToSatMutualVisibilityDetector(String, String, SensorModel, SensorModel, boolean, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Constructor to be used for multi spacecraft propagation only (
MultiPropagator).
- SatToSatMutualVisibilityDetector(String, String, SensorModel, SensorModel, boolean, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Constructor to be used for multi-spacecraft propagation only (
MultiPropagator).
- SatToSatMutualVisibilityDetector(String, String, SensorModel, SensorModel, boolean, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean, SatToSatMutualVisibilityDetector.SatToSatLinkType) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SatToSatMutualVisibilityDetector
-
Constructor to be used for multi-spacecraft propagation only (
MultiPropagator).
- SatToSatMutualVisibilityDetector.SatToSatLinkType - Enum in fr.cnes.sirius.patrius.events.detectors
-
Type of link.
- SATURN - Static variable in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Predefined name for Saturn.
- SATURN_BARY - Static variable in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Predefined name for Saturn barycenter.
- scalAbsoluteTolerance - Variable in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed absolute scalar error.
- SCALAR - Static variable in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Scalar
- scalarAdd(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
Add a scalar
- scalarAdd(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialFunction
-
Add a scalar
- scalarAdd(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialPrimitive
-
- scalarAdd(T) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Increment each entry of this matrix.
- scalarAdd(double) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns the result of adding a scalar d to the entries of this matrix.
- scalarAdd(double) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Returns the result of adding a scalar d to the entries of this matrix.
- scalarAdd(double) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Returns the result of adding a scalar d to the entries of this matrix.
- scalarAdd(T) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Increment each entry of this matrix.
- scalarAdd(double) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Returns the result of adding a scalar d to the entries of this matrix.
- scalarAdd(double) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Returns the result of adding a scalar d to the entries of this matrix.
- scalarAdd(double) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the result of adding a scalar d to the entries of this matrix.
- scalarAdd(T) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Increment each entry of this matrix.
- scalarAdd(double) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns the result of adding a scalar d to the entries of this matrix.
- scalarAdd(double) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Returns the result of adding a scalar d to the entries of this matrix.
- scalarDivide(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
Divide by a scalar
- scalarDivide(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialFunction
-
Divide by a scalar
- scalarDivide(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialPrimitive
-
Divide by a scalar
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
Multiply by a scalar
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialFunction
-
Multiply by a scalar
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialPrimitive
-
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Multiply the instance by a scalar.
- scalarMultiply(T) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Multiply the instance by a scalar.
- scalarMultiply(T) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Multiply each entry by d.
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns the result of multiplying the entries of this matrix by the scalar d.
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Returns the result of multiplying the entries of this matrix by the scalar d.
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Returns the result of multiplying the entries of this matrix by the scalar d.
- scalarMultiply(T) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Multiply each entry by d.
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Returns the result of multiplying the entries of this matrix by the scalar d.
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Returns the result of multiplying the entries of this matrix by the scalar d.
- scalarMultiply(double) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the result of multiplying the entries of this matrix by the scalar d.
- scalarMultiply(T) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Multiply each entry by d.
- scalarMultiply(double) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns the result of multiplying the entries of this matrix by the scalar d.
- scalarMultiply(double) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Returns the result of multiplying the entries of this matrix by the scalar d.
- scalarMultiply(double, double[][]) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
-
Return coef * matrix.
- scalarSubtract(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierSeries
-
Subtract a scalar
- scalarSubtract(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialFunction
-
Subtract a scalar
- scalarSubtract(double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialPrimitive
-
Subtract a scalar
- scalb(int) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Multiply the instance by a power of 2.
- scalb(double, int) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Multiply a double number by a power of 2.
- scalb(float, int) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Multiply a float number by a power of 2.
- scalb(double, int) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Multiply a double number by a power of 2.
- scalb(float, int) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Multiply a float number by a power of 2.
- scalb(double, int) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Multiply a double number by a power of 2.
- scalb(float, int) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Multiply a float number by a power of 2.
- scalb(double, int) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Multiply a double number by a power of 2.
- scalb(float, int) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Multiply a float number by a power of 2.
- scalb(double, int) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Multiply a double number by a power of 2.
- scalb(float, int) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Multiply a float number by a power of 2.
- scalb(double, int) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Multiply a double number by a power of 2.
- scalb(float, int) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Multiply a float number by a power of 2.
- scalb(double, int) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Multiply a double number by a power of 2.
- scalb(float, int) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Multiply a float number by a power of 2.
- scalb(int) - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Multiply the instance by a power of 2.
- scalb(double, int) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Multiply a double number by a power of 2.
- scalb(float, int) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Multiply a float number by a power of 2.
- scalb(double, int) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Multiply a double number by a power of 2.
- scalb(float, int) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Multiply a float number by a power of 2.
- scale(double) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Returns the interval scaled by a given factor with respect to its midpoint.
- scale(double, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Returns the interval scaled by a given factor with respect to the specified epoch.
- scaleArray(double[], double) - Static method in class fr.cnes.sirius.patrius.math.transform.TransformUtils
-
Multiply every component in the given real array by the
given real number.
- scaleArray(Complex[], double) - Static method in class fr.cnes.sirius.patrius.math.transform.TransformUtils
-
Multiply every component in the given complex array by the
given real number.
- scaled - Variable in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
First scaled derivative (h y').
- scalRelativeTolerance - Variable in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed relative scalar error.
- SchwarzschildRelativisticEffect - Class in fr.cnes.sirius.patrius.forces.relativistic
-
Computation of the relativistic Schwarzschild effect.
- SchwarzschildRelativisticEffect(double, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.relativistic.SchwarzschildRelativisticEffect
-
Constructor.
- SchwarzschildRelativisticEffect(double) - Constructor for class fr.cnes.sirius.patrius.forces.relativistic.SchwarzschildRelativisticEffect
-
Constructor with partial derivative computation by default.
- SCILAB_FORMAT - Static variable in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
- Screw - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
This class represents a screw
- Screw(Screw) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Screw
-
Build a copy of a screw.
- Screw(Vector3D, Vector3D, Vector3D) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Screw
-
Constructor
- SDP4 - Static variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Identifier for SDP4 type of ephemeris.
- SDP8 - Static variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Identifier for SDP8 type of ephemeris.
- search(UnivariateFunction, GoalType, double, double) - Method in class fr.cnes.sirius.patrius.math.optim.univariate.BracketFinder
-
Search new points that bracket a local optimum of the function.
- searchForFitnessUpdate(Population) - Method in class fr.cnes.sirius.patrius.math.genetics.Chromosome
-
Searches the population for a chromosome representing the same solution, and if it finds one,
updates the fitness to its value.
- SearchIndexLibrary - Class in fr.cnes.sirius.patrius.math.utils
-
Index search algorithms based on method BinarySearch, coupled with dichotomy.
- SearchInterval - Class in fr.cnes.sirius.patrius.math.optim.univariate
-
Search interval and (optional) start value.
- SearchInterval(double, double, double) - Constructor for class fr.cnes.sirius.patrius.math.optim.univariate.SearchInterval
-
- SearchInterval(double, double) - Constructor for class fr.cnes.sirius.patrius.math.optim.univariate.SearchInterval
-
- searchSegment(int, double, int[], double[], String[]) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkFile
-
Search through loaded SPK files to find the highest-priority segment applicable to the body and time specified
and buffer searched segments in the process, to attempt to avoid re-reading files.
- searchXIndex - Variable in class fr.cnes.sirius.patrius.math.analysis.interpolation.AbstractLinearIntervalsFunction
-
xtab used for search and satisfies condition from SearchIndex.
- searchYIndex - Variable in class fr.cnes.sirius.patrius.math.analysis.interpolation.AbstractLinearIntervalsFunction
-
ytab used for search and satisfies condition from SearchIndex.
- searchZIndex - Variable in class fr.cnes.sirius.patrius.math.analysis.interpolation.AbstractLinearIntervalsFunction
-
ztab used for search and satisfies condition from SearchIndex.
- SecantSolver - Class in fr.cnes.sirius.patrius.math.analysis.solver
-
Implements the Secant method for root-finding (approximating a
zero of a univariate real function).
- SecantSolver() - Constructor for class fr.cnes.sirius.patrius.math.analysis.solver.SecantSolver
-
Construct a solver with default accuracy (1e-6).
- SecantSolver(double) - Constructor for class fr.cnes.sirius.patrius.math.analysis.solver.SecantSolver
-
Construct a solver.
- SecantSolver(double, double) - Constructor for class fr.cnes.sirius.patrius.math.analysis.solver.SecantSolver
-
Construct a solver.
- SecondaryEquations - Interface in fr.cnes.sirius.patrius.math.ode
-
This interface allows users to add secondary differential equations to a primary
set of differential equations.
- SecondarySpacecraft - Class in fr.cnes.sirius.patrius.assembly.models
-
Secondary spacecraft to be used in events detections.
- SecondarySpacecraft(Assembly, Propagator, String) - Constructor for class fr.cnes.sirius.patrius.assembly.models.SecondarySpacecraft
-
Constructor for a secondary spacecraft to be used in events detections.
- SecondMoment - Class in fr.cnes.sirius.patrius.math.stat.descriptive.moment
-
Computes a statistic related to the Second Central Moment.
- SecondMoment() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SecondMoment
-
Create a SecondMoment instance
- SecondMoment(SecondMoment) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SecondMoment
-
Copy constructor, creates a new SecondMoment identical
to the original
- SecondOrderDifferentialEquations - Interface in fr.cnes.sirius.patrius.math.ode
-
This interface represents a second order differential equations set.
- SecondOrderIntegrator - Interface in fr.cnes.sirius.patrius.math.ode
-
This interface represents a second order integrator for
differential equations.
- SecondOrderMapper - Class in fr.cnes.sirius.patrius.propagation.numerical
-
Second-order / first order integrator state mapper.
- SecondOrderMapper() - Constructor for class fr.cnes.sirius.patrius.propagation.numerical.SecondOrderMapper
-
- SecondOrderMapper(List<AdditionalEquationsAndTolerances>) - Constructor for class fr.cnes.sirius.patrius.propagation.numerical.SecondOrderMapper
-
Constructor.
- SecondOrderStateMapper - Interface in fr.cnes.sirius.patrius.math.ode.nonstiff.cowell
-
Mapper for second order integrator state vector.
- SectorField - Class in fr.cnes.sirius.patrius.fieldsofview
-
This class defines a "sector" field of view.
- SectorField(String, Vector3D, Vector3D, Vector3D) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.SectorField
-
Constructor for the "sector" field of view.
- SecularAndHarmonic - Class in fr.cnes.sirius.patrius.math.fitting
-
Class for fitting evolution of osculating orbital parameters.
- SecularAndHarmonic(int, double...) - Constructor for class fr.cnes.sirius.patrius.math.fitting.SecularAndHarmonic
-
Simple constructor.
- secularOrbitIn - Variable in class fr.cnes.sirius.patrius.propagation.analytical.AbstractLyddanePropagator
-
Secular orbit.
- Segment - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
Simple container for a two-points segment.
- Segment(Vector3D, Vector3D, Line) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Segment
-
Build a segment.
- Segment(Vector3D, Vector3D) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Segment
-
Build a segment.
- Segment - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.twod
-
Simple container for a two-points segment.
- Segment(Vector2D, Vector2D, Line) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Segment
-
Build a segment.
- Segment(Vector2D, Vector2D) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Segment
-
Build a segment.
- SEIDELMANN_UA - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
UA from the 1992 Astronomical Almanac by P.
- select(Population) - Method in interface fr.cnes.sirius.patrius.math.genetics.SelectionPolicy
-
Select two chromosomes from the population.
- select(Population) - Method in class fr.cnes.sirius.patrius.math.genetics.TournamentSelection
-
Select two chromosomes from the population.
- selectDaf(int) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.FindArraysDAF
-
Select a DAF that already has a search in progress as the one to continue searching.
- selectExtrapolator(TLE) - Static method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
Selects the extrapolator to use with the selected TLE.
- selectExtrapolator(TLE, AttitudeProvider, MassProvider) - Static method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
Selects the extrapolator to use with the selected TLE.
- selectExtrapolator(TLE, AttitudeProvider, AttitudeProvider, MassProvider) - Static method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
Selects the extrapolator to use with the selected TLE.
- SelectionPolicy - Interface in fr.cnes.sirius.patrius.math.genetics
-
Algorithm used to select a chromosome pair from a population.
- selectParamAndStep(Parameter, double) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Select the parameters to consider for Jacobian processing.
- selectParameters(Parameter...) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Select the parameters to consider for Jacobian processing.
- selectParameters(List<Parameter>) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Select the parameters to consider for Jacobian processing.
- SEMICOLON - Static variable in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Semicolon character (';') .
- SemiVariance - Class in fr.cnes.sirius.patrius.math.stat.descriptive.moment
-
Computes the semivariance of a set of values with respect to a given cutoff value.
- SemiVariance() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with default (true) biasCorrected property and default (Downside)
varianceDirection property.
- SemiVariance(boolean) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with the specified biasCorrected property and default (Downside)
varianceDirection property.
- SemiVariance(SemiVariance.Direction) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with the specified Direction property
and default (true) biasCorrected property
- SemiVariance(boolean, SemiVariance.Direction) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with the specified isBiasCorrected property and the specified
Direction property.
- SemiVariance(SemiVariance) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Copy constructor, creates a new SemiVariance identical
to the original
- SemiVariance.Direction - Enum in fr.cnes.sirius.patrius.math.stat.descriptive.moment
-
The direction of the semivariance - either upside or downside.
- SensorInhibitionDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Event detector for the inhibition of a sensor.
- SensorInhibitionDetector(Assembly, String, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Constructor for the "inhibition" detector The default implementation behaviour is to
continue propagation when
entering the zone and to
stop when
exiting
the zone.
- SensorInhibitionDetector(Assembly, String, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Constructor for the "inhibition" detector
- SensorInhibitionDetector(SensorModel, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Constructor for the "inhibition" detector The default implementation behaviour is to
continue propagation when
entering the zone and to stop when exiting the zone.
- SensorInhibitionDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Constructor for the "inhibition" detector
- SensorInhibitionDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorInhibitionDetector
-
Constructor for the "inhibition" detector
- SensorModel - Class in fr.cnes.sirius.patrius.assembly.models
-
- SensorModel(Assembly, String) - Constructor for class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Constructor for a sensor model.
- SensorProperty - Class in fr.cnes.sirius.patrius.assembly.properties
-
This class represents a generic sensor property for a part of the assembly.
- SensorProperty(Vector3D) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
Constructor of the generic sensor property
- SensorVisibilityDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Event detector for the visibility of a sensor.
- SensorVisibilityDetector(Assembly, String, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Constructor for the "visibility view" detector The default implementation behaviour is to
continue propagation when
entering the zone and to stop when exiting the zone.
- SensorVisibilityDetector(Assembly, String, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Constructor for the "visibility view" detector.
- SensorVisibilityDetector(SensorModel, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Constructor for the "visibility view" detector The default implementation behaviour is to
continue propagation when
entering the zone and to stop when exiting the zone.
- SensorVisibilityDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Constructor for the "visibility" detector.
- SensorVisibilityDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Constructor for the "visibility" detector.
- sequence - Variable in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeEphemerisGenerator
-
Attitude legs sequence.
- sequence(int, int, int) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Returns an array of size integers starting at start,
skipping stride numbers.
- Sequences - Class in fr.cnes.sirius.patrius.utils.legs
-
- SerializableFunction<T,R> - Interface in fr.cnes.sirius.patrius.utils.serializablefunction
-
Extension of the
Function interface to specify that these implementations must be serializable.
- SerializablePredicate<T> - Interface in fr.cnes.sirius.patrius.utils.serializablefunction
-
Extension of the
Predicate to specify that these implementations must be serializable.
- SerializableToDoubleFunction<T> - Interface in fr.cnes.sirius.patrius.utils.serializablefunction
-
Extension of the
ToDoubleFunction to specify that these implementations must be serializable.
- serializeRealMatrix(RealMatrix, String) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
- serializeRealMatrix(RealMatrix, ObjectOutputStream) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
- serializeRealVector(RealVector, ObjectOutputStream) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
- SeriesTerm - Class in fr.cnes.sirius.patrius.data
-
Base class for nutation series terms.
- SeriesTerm(double, double) - Constructor for class fr.cnes.sirius.patrius.data.SeriesTerm
-
Simple constructor for the base class.
- set(int, ArrayFieldVector<T>) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Set a set of consecutive elements.
- set(T) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Set all elements to a single value.
- set(double) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Set all elements to a single value.
- set(T) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldVector
-
Set all elements to a single value.
- set(double) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Set all elements to a single value.
- setA(double[][]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the equalities constraints matrix
- setA(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the equalities constraints matrix
- setAccuracy(int) - Method in class fr.cnes.sirius.patrius.files.general.SatelliteInformation
-
Set the accuracy for this satellite.
- setAdditionalStateProviders(List<AdditionalStateProvider>) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
-
sets the additionalStateProviders
- setAdditionalStateTolerance(String, double[], double[], String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Add additional state tolerances.
- setAdditionalStateTolerance(String, double[], double[]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Add additional state tolerances.
- setAe(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.BalminoGravityModel
-
Set the equatorial radius.
- setAe(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.CunninghamGravityModel
-
Set the equatorial radius.
- setAe(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.DrozinerGravityModel
-
Set the equatorial radius.
- setAe(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
- setAe(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.VariablePotentialGravityModel
-
Set the equatorial radius.
- setAerodynamicProperties(AssemblyBuilder, String, double) - Method in class fr.cnes.sirius.patrius.assembly.vehicle.AerodynamicProperties
-
Set aerodynamic property to a part (it modifies vehicle surface model as a function of the
multplicative factor).
- setAerodynamicsProperties(AerodynamicCoefficient, AerodynamicCoefficient) - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Set aerodynamics properties only if possible : main shape must be a sphere or there must be
no solar panels.
- setAerodynamicsProperties(double, double) - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Set aerodynamics properties as constants.
- setAgency(String) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the agency string for this SP3 file.
- setAlpha(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the calibration parameter for line search
- setAlt(double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for alt.
- setAMatrix(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Set the A matrix
- setAngle(double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Set the angle of the line.
- setAngularDerivativesFilter(AngularDerivativesFilter) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Setter for the filter to use in interpolation.
- setAp(double[]) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.ApCoef
-
Setter for AP.
- setAp(int, int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.ApCoef
-
Setter for a specific element of the AP array.
- setAp(double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for ap.
- setApA(ApCoef) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for apA.
- setApA(double[]) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for apA.
- setAPMap(NavigableMap<AbsoluteDate, Double>) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Set the AP map.
- setArity(int) - Method in class fr.cnes.sirius.patrius.math.genetics.TournamentSelection
-
Sets the arity (number of chromosomes drawn to the tournament).
- setAttitudeProvider(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Set attitude provider for forces and events computation.
- setAttitudeProvider(AttitudeProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Set attitude provider for defined spacecraft.
- setAttitudeProvider(AttitudeProvider, String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Set attitude provider for defined spacecraft.
- setAttitudeProvider(AttitudeProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set attitude provider for defined spacecraft.
- setAttitudeProvider(MultiAttitudeProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set attitude provider.
- setAttitudeProvider(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Set attitude provider for forces and events computation.
- setAttitudeProvider(AttitudeProvider) - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Set attitude provider for forces and events computation.
- setAttitudeProvider(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set attitude provider for forces and events computation.
- setAttitudeProvider(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Set attitude provider for forces and events computation.
- setAttitudeProviderEvents(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Set attitude provider for events computation.
- setAttitudeProviderEvents(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.propagation.analytical.AnalyticalEphemerisModeHandler
-
Set attitude provider for events computation.
- setAttitudeProviderEvents(AttitudeProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Set attitude provider for events computation.
- setAttitudeProviderEvents(AttitudeProvider, String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Set attitude provider for events computation.
- setAttitudeProviderEvents(AttitudeProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set attitude provider for events computation.
- setAttitudeProviderEvents(MultiAttitudeProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set attitude provider for events.
- setAttitudeProviderEvents(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Set attitude provider for events computation.
- setAttitudeProviderEvents(AttitudeProvider) - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Set attitude provider for events computation.
- setAttitudeProviderEvents(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set attitude provider for events computation.
- setAttitudeProviderEvents(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Set attitude provider for events computation.
- setAttitudeProviderForces(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Set attitude provider for forces computation.
- setAttitudeProviderForces(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.propagation.analytical.AnalyticalEphemerisModeHandler
-
Set attitude provider for forces computation.
- setAttitudeProviderForces(AttitudeProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Set attitude provider for forces computation.
- setAttitudeProviderForces(AttitudeProvider, String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Set attitude provider for forces computation.
- setAttitudeProviderForces(AttitudeProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set attitude provider for forces computation.
- setAttitudeProviderForces(MultiAttitudeProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set attitude provider for forces.
- setAttitudeProviderForces(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Set attitude provider for forces computation.
- setAttitudeProviderForces(AttitudeProvider) - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Set attitude provider for forces computation.
- setAttitudeProviderForces(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set attitude provider for forces computation.
- setAttitudeProviderForces(AttitudeProvider) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Set attitude provider for forces computation.
- setAttitudeRepresentedFrame(Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.AngularMomentumExcessDetector
-
Define the frame represented by the attitude law
- setAttitudeRepresentedFrame(Frame, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.FlightDomainExcessDetector
-
Define the frame represented by the attitude law and the desired flight domain represented frame
- setAttribute(Object) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BSPTree
-
Associate an attribute with the instance.
- setAvoidFillIn(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Set true if no methods that cause fill-in in the original matrices will be called or false otherwise
- setAvoidIncreaseSparsity(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Set true if no method for making normal equations sparser will be applied or false otherwise
- setAvoidPresolvingFillIn(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set true if no methods that cause fill-in in the original matrices will be called during the presolving phase
or false otherwise
- setAvoidPresolvingIncreaseSparsity(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set true if no method for making normal equations sparser will be applied during the presolving phase
or false otherwise
- setAvoidScaling(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Set if the matrix scaling should be disabled (true) or not (false)
- setB(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the equalities constraints vector
- setB(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the equalities constraints vector
- setBarycenter(Vector<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Set the barycenter of the instance.
- setBeta(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the calibration parameter for line search
- setBiasCorrected(boolean) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Sets the biasCorrected property.
- setBiasCorrected(boolean) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
- setBiasCorrected(boolean) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Variance
-
- setBoldLineSeparator(String) - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Setter for the String representing the bold line separator.
- setBuffered(boolean) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Set whether name record containing name of current array is buffered.
- setC(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the linear objective function
- setC(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the linear objective function
- setCacheSize(int) - Static method in class fr.cnes.sirius.patrius.bodies.JPLHistoricEphemerisLoader
-
Set ephemeris cache size in days.
- setCacheSlotsNumber(int) - Static method in class fr.cnes.sirius.patrius.utils.PatriusConfiguration
-
Set the number of slots to use in caches.
- setCenter(PVCoordinatesProvider) - Method in class fr.cnes.sirius.patrius.frames.LocalOrbitalFrame
-
- setCentralTermContribution(boolean) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractHarmonicGravityModel
-
Set the boolean for the central term contribution (true if the central term is considered, false if not).
- setCentralTermContribution(boolean) - Method in class fr.cnes.sirius.patrius.forces.gravity.NewtonianGravityModel
-
Set the boolean for the central term contribution (true if the central term is considered, false if not).
- setCheckKKTSolutionAccuracy(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set true if every inversion of the system must have an accuracy that satisfy
the given toleranceKKT, false otherwise.
- setCheckKKTSolutionAccuracy(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Set if the KTT solution accuracy is preserved or not
- setCheckOptimalLagrangianBounds(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set if the bound conditions on the optimal equality constraints Lagrangian coefficients are respected.
- setCheckPrevious(boolean) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the boolean indicating if the previous segment needs to be checked.
- setCheckProgressConditions(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set true if a progress in the relevant algorithm norms is
required during iterations, or false if the iteration will
be exited with a warning
- setCIRFPrecessionNutation(PrecessionNutation) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationBuilder
-
Setter for CIRF precession nutation provider in the builder.
- setCIRFPrecessionNutationModel(PrecessionNutation) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Set the precession nutation model.
- setClockCorrection(double) - Method in class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
Set the clock correction to the given value.
- setClockRateChange(double) - Method in class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
Set the clock rate change to the given value.
- setClosestPointOnShape(BodyPoint) - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyPoint
-
Setter for the entered body point as closest point on shape.
- setClosestPointOnShape(BodyPoint) - Method in class fr.cnes.sirius.patrius.bodies.EllipsoidPoint
-
Setter for the entered body point as closest point on shape.
- setClosestPointOnShape(BodyPoint) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetPoint
-
Setter for the entered body point as closest point on shape.
- setColumn(int, T[]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Set the entries in column number column as a column matrix.
- setColumn(int, double[]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Replaces the entries of a given column with the entries of the specified data array.
- setColumn(int, double[]) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Replaces the entries of a given column with the entries of the specified data array.
- setColumn(int, T[]) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Set the entries in column number column as a column matrix.
- setColumn(int, double[]) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Replaces the entries of a given column with the entries of the specified data array.
- setColumn(int, double[]) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Replaces the entries of a given column with the entries of the specified data array.
- setColumn(int, T[]) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Set the entries in column number column as a column matrix.
- setColumn(int, double[]) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Replaces the entries of a given column with the entries of the specified data array.
- setColumnMatrix(int, FieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Set the entries in column number column as a column matrix.
- setColumnMatrix(int, RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Replaces the entries of a given column with the entries of the specified column matrix.
- setColumnMatrix(int, RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Replaces the entries of a given column with the entries of the specified column matrix.
- setColumnMatrix(int, FieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Set the entries in column number column as a column matrix.
- setColumnMatrix(int, BlockFieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Sets the entries in column number column as a column matrix.
- setColumnMatrix(int, RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Replaces the entries of a given column with the entries of the specified column matrix.
- setColumnMatrix(int, BlockRealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Sets the entries in column number column as a column matrix.
- setColumnMatrix(int, RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Replaces the entries of a given column with the entries of the specified column matrix.
- setColumnMatrix(int, FieldMatrix<T>) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Set the entries in column number column as a column matrix.
- setColumnMatrix(int, RealMatrix) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Replaces the entries of a given column with the entries of the specified column matrix.
- setColumnVector(int, FieldVector<T>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Set the entries in column number column as a vector.
- setColumnVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Replaces the entries of a given column with the entries of the specified vector.
- setColumnVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Replaces the entries of a given column with the entries of the specified vector.
- setColumnVector(int, FieldVector<T>) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Set the entries in column number column as a vector.
- setColumnVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Replaces the entries of a given column with the entries of the specified vector.
- setColumnVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Replaces the entries of a given column with the entries of the specified vector.
- setColumnVector(int, FieldVector<T>) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Set the entries in column number column as a vector.
- setColumnVector(int, RealVector) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Replaces the entries of a given column with the entries of the specified vector.
- setCompleteState(double[]) - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Set the complete current state.
- setConfiguration(FramesConfiguration) - Static method in class fr.cnes.sirius.patrius.frames.FramesFactory
-
Sets a new configuration.
- setConstantAP(double) - Method in interface fr.cnes.sirius.patrius.stela.forces.solaractivity.IStelaSolarActivity
-
Set geomagnetic activity coefficient to the input value.
- setConstantF107(double) - Method in interface fr.cnes.sirius.patrius.stela.forces.solaractivity.IStelaSolarActivity
-
Set solar flux value to the input parameter's value.
- setControlFactors(double, double, double, double) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the step size control factors.
- setConvergenceThreshold(double) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
- setCoordinate(PVCoordinates) - Method in class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
Set the coordinate for this entry.
- setCoordinateSystem(String) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the coordinate system used for the orbit entries.
- setCoriolisRelativisticEffect(CoriolisRelativisticEffect) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setCost(double) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
-
Sets the cost.
- setD(int, double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Output
-
Setter for ith density component.
- setData(double[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AbstractUnivariateStatistic
-
Set the data array.
- setData(double[], int, int) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.AbstractUnivariateStatistic
-
Set the data array.
- setData(double[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Percentile
-
Set the data array.
- setData(double[], int, int) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Percentile
-
Set the data array.
- setDataUsed(String) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the data used indicator for this SP3 file.
- setDayFraction(double) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the day fraction for this SP3 file.
- setdDragdt(double[]) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Specify the drag values, only used for n steps drag computation purposes
- setDefaultAbsolutePositivityThreshold(Double) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Sets the default absolute positivity threshold, above which a value is considered to be
positive.
- setDefaultAbsoluteSymmetryThreshold(Double) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Sets the default absolute threshold above which off-diagonal elements are considered
different.
- setDefaultDecomposition(Function<RealMatrix, Decomposition>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Sets the decomposition builder the
getInverse() method should
use by default when computing the inverse of the matrix.
- setDefaultDecomposition(Function<RealMatrix, Decomposition>) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Sets the decomposition builder the
getInverse() method should
use by default when computing the inverse of the matrix.
- setDefaultRelativePositivityThreshold(Double) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Sets the default relative positivity threshold, above which a value is considered to be
numerically significant when compared to another value.
- setDefaultRelativeSymmetryThreshold(Double) - Static method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Sets the default relative threshold above which off-diagonal elements are considered
different.
- setDenominatorFormat(NumberFormat) - Method in class fr.cnes.sirius.patrius.math.fraction.AbstractFormat
-
Modify the denominator format.
- setDH(double) - Method in class fr.cnes.sirius.patrius.bodies.CelestialBodyTabulatedOrientation
-
Setter for the finite difference delta value.
- setDiagonalLength(int) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.UpperDiagonalHKKTSolver
-
Set diagonal length
- setDirty(boolean) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Setter for the boolean for force models / selected parameters consistency.
- setDistanceEpsilon(double) - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
Setter for the distance epsilon below which the height coordinate is neglected.
- setDistanceEpsilon(double) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Setter for the distance epsilon below which the height coordinate is neglected.
- setDiurnalRotation(DiurnalRotation) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationBuilder
-
Setter for diurnal rotation provider in the builder.
- setDiurnalRotationModel(DiurnalRotation) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Set the diurnal rotation model.
- setDoy(int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for doy.
- setDragCoef(AbstractStelaDragCoef) - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Sets the drag coefficient associated with the object.
- setDragForce(DragForce) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setDryMass(double) - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Set vehicle dry mass.
- setEarthPotentialAttractionModel(ForceModel) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setEclipsesComputation(boolean) - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Setter for enabling/disabling eclipses computation.
- setElement(int, double) - Method in interface fr.cnes.sirius.patrius.math.util.DoubleArray
-
Sets the element at the specified index.
- setElement(int, double) - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Sets the element at the specified index.
- setElitismRate(double) - Method in class fr.cnes.sirius.patrius.math.genetics.ElitisticListPopulation
-
Sets the elitism rate, i.e. how many best chromosomes will be directly transferred to the next generation [in %].
- setEntry(int, int, T) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Sets the entry at the specified row and column to a new value.
- setEntry(int, int, T) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Sets the entry at the specified row and column to a new value.
- setEntry(int, T) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Set a single element.
- setEntry(int, double) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Set a single element.
- setEntry(int, int, double) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Sets the entry at the specified row and column to a new value.
- setEntry(int, int, double) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Sets the entry at the specified row and column to a new value.
- setEntry(int, int, T) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Sets the entry at the specified row and column to a new value.
- setEntry(int, int, double) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Sets the entry for the specified row and column.
- setEntry(int, int, double) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Sets the entry at the specified row and column to a new value.
- setEntry(int, int, T) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, T) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldVector
-
Set a single element.
- setEntry(int, int, double) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Sets the entry at the specified row and column to a new value.
- setEntry(int, double) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Set a single element.
- setEOPHistory(EOPHistory) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationBuilder
-
Setter for history provider in the builder.
- setEOPHistory(EOPHistory) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Set the EOP history.
- setEphemeris(CelestialBodyEphemeris) - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
Set an ephemeris to the celestial point.
- setEphemeris(CelestialBodyEphemeris) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialPoint
-
Set an ephemeris to the celestial point.
- setEphemeris(CelestialBodyEphemeris) - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Set an ephemeris to the celestial point.
- setEphemerisMode() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Set the propagator to ephemeris generation mode.
- setEphemerisMode() - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Not authorized method: throws an unchecked exception when called.
- setEphemerisMode() - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Set the propagator to ephemeris generation mode.
- setEphemerisMode() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set the propagator to ephemeris generation mode.
- setEphemerisMode() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Set the propagator to ephemeris generation mode.
- setEphemerisMode() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Set the propagator to ephemeris generation mode.
- setEphemerisMode() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set the propagator to ephemeris generation mode.
- setEpoch(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.files.general.SatelliteTimeCoordinate
-
Set the epoch for this coordinate.
- setEpoch(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the epoch of the SP3 file.
- setEpochInterval(double) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the epoch interval for this SP3 file.
- setEpsilonSignalPropagation(double) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Set the epsilon for signal propagation used in
#spacecraftsMaskingDistance(AbsoluteDate, AbsoluteDate, PropagationDelayType, LinkType) and
#celestialBodiesMaskingDistance(AbsoluteDate, AbsoluteDate, PropagationDelayType, LinkType) methods.
- setEpsilonSignalPropagation(double) - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
Setter for the epsilon for signal propagation used in
#getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, PropagationDelayType)
method.
- setEpsilonSignalPropagation(double) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Setter for the epsilon for signal propagation used in
#getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, PropagationDelayType)
method.
- setEpsilonSignalPropagation(double) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Setter for the epsilon for signal propagation when signal propagation is taken into account.
- setEpsilonSignalPropagation(double) - Method in class fr.cnes.sirius.patrius.forces.radiation.LightingRatio
-
Setter for the epsilon for signal propagation when signal propagation is taken into account.
- setEpsilonSignalPropagation(double) - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Setter for the epsilon for signal propagation when signal propagation is taken into account.
- setEquations(ExpandableStatefulODE) - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Set the equations.
- setExpectedSolution(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Just for testing porpose
- setExpense(int) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the expense associated to a body.
- setF0(ConvexMultivariateRealFunction) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the objective function to minimize
- setF0(ConvexMultivariateRealFunction) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the objective function to minimize
- setF107(double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for f107.
- setF107A(double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for f107A.
- setFi(ConvexMultivariateRealFunction[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the inequalities constraints array
- setFi(ConvexMultivariateRealFunction[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the inequalities constraints array
- setFiring(boolean) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ConstantThrustError
-
Set maneuver status.
- setFiring(boolean) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ContinuousThrustManeuver
-
Set maneuver status.
- setFirstCovarianceMatrix(RealMatrix, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
Allows to change the CovarianceMatrix standing for the lower bound of the
interpolation interval, associated with t1.
- setForward(boolean) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiEphemerisModeHandler
-
Set forward propagation flag.
- setFrame(UpdatableFrame) - Method in class fr.cnes.sirius.patrius.assembly.MainPart
-
Method to modify the frame of the main part.
- setFunction(UnivariateFunction, double) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierDecompositionEngine
-
- setG(double[][]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the linear inequalities constraints matrix
- setG(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the linear inequalities constraints matrix
- setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the geometric mean.
- setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Sets the implementation for the geometric mean.
- setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the geometric mean.
- setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the geometric mean.
- setGeometricMeanImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the gemoetric mean.
- setgLat(double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for gLat.
- setgLong(double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for gLong.
- setGM(double) - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Set a central attraction coefficient to the celestial point.
- setGM(double) - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialPoint
-
Set a central attraction coefficient to the celestial point.
- setGM(double) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialPoint
-
Set a central attraction coefficient to the celestial point.
- setGM(double) - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Set a central attraction coefficient to the celestial point.
- setGM(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.AttractionData
-
Set the central attraction coefficient.
- setGpsWeek(int) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the GPS week of the SP3 file.
- setGravityModel(GravityModel) - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Setter for a gravitational attraction model to the body.
- setGravityModel(GravityModel) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Setter for a gravitational attraction model to the body.
- setGravityModel(GravityModel) - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Setter for a gravitational attraction model to the body.
- setGVector(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Set the g vector
- setH(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the linear inequalities constraints coefficients
- setH(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the linear inequalities constraints coefficients
- setHandle(int) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Setter for the state handle.
- setHandle(int) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceKernelInfo
-
Setter for the handle associated to the file.
- setHandled(boolean) - Method in class fr.cnes.sirius.patrius.bodies.mesh.Triangle
-
Set a boolean representing triangle status for fast algorithms.
- setHighestFile(int) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the highest file number searched during the construction of the segment list.
- setHMatrix(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Set the H matrix
- setHPos(double) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Setter for the step used for finite difference computation with respect to spacecraft position
- setHVector(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Set the h vector
- setIEEEFlags(int) - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Sets the IEEE 854 status flags.
- setIEEEFlagsBits(int) - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Sets some bits in the IEEE 854 status flags, without changing the already set bits.
- setIndex(int) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector.Entry
-
Set the index of the entry.
- setIndex1stOrder(int) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquationsAndTolerances
-
Set position of equations in first order state vector (initially unknown).
- setIndex2ndOrder(int) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquationsAndTolerances
-
Set position of equations in second order state vector (initially unknown).
- setIndexCurrSummary(int) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Setter for the index of the current summary within the summary record.
- setInertia(RealMatrix, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.AngularMomentumExcessDetector
-
Define the inertia matrix (from CoM and in vehicle axis)
- setInertiaMatrix(Matrix3D) - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
-
Sets the inertia matrix
- setInhibitionFieldsAndTargets(IFieldOfView[], PVCoordinatesProvider[], ApparentRadiusProvider[]) - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
Sets the arrays of inhibition fields and the associated targets : the two array must
have the same length.
- setInitialJacobians(SpacecraftState) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Set the initial value of the Jacobian with respect to state and parameter.
- setInitialJacobians(SpacecraftState, double[][], double[][]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Set the initial value of the Jacobian with respect to state and parameter.
- setInitialJacobians(SpacecraftState, double[][]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Set the initial value of the Jacobian with respect to state.
- setInitialJacobians(SpacecraftState, Parameter, double[]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Set the initial value of the Jacobian with respect to state.
- setInitialJacobians(SpacecraftState, double[][], double[][], double[]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.JacobiansMapper
-
Set the Jacobian with respect to state into a one-dimensional additional state array.
- setInitialLagrangian(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set a starting point for the Lagrangian multipliers
- setInitialMainStateJacobian(double[][]) - Method in class fr.cnes.sirius.patrius.math.ode.JacobianMatrices
-
Set the initial value of the Jacobian matrix with respect to state.
- setInitialParameterJacobian(String, double[]) - Method in class fr.cnes.sirius.patrius.math.ode.JacobianMatrices
-
Set the initial value of a column of the Jacobian matrix with respect to one parameter.
- setInitialPoint(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the feasible starting point for the minimum search
- setInitialState(SpacecraftState) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Set the initial state.
- setInitialState(SpacecraftState, double, boolean) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Set the initial state.
- setInitialStepSize(double) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the initial step size.
- setIntegrator(UnivariateIntegrator) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierDecompositionEngine
-
- setIntegrator(FirstOrderIntegrator) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set the integrator.
- setInteriorPointMethod(String) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the chosen interior-point method
- setInterpolatedDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.sampling.AdaptedStepHandler
-
Set the interpolated date.
- setInterpolatedDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.sampling.BasicStepInterpolator
-
Set the interpolated date.
- setInterpolatedDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
-
Set the interpolated date.
- setInterpolatedDate(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiPatriusStepInterpolator
-
Set the interpolated date.
- setInterpolatedDate(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.sampling.PatriusStepInterpolator
-
Set the interpolated date.
- setInterpolatedDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
-
Set the interpolated date.
- setInterpolatedTime(double) - Method in class fr.cnes.sirius.patrius.math.ode.ContinuousOutputModel
-
Set the time of the interpolated point.
- setInterpolatedTime(double) - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Set the time of the interpolated point.
- setInterpolatedTime(double) - Method in interface fr.cnes.sirius.patrius.math.ode.sampling.StepInterpolator
-
Set the time of the interpolated point.
- setInterpolationControl(boolean, int) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the interpolation order control parameter.
- setJacobianWrtParametersEccentric(double[][]) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- setJacobianWrtParametersMean(double[][]) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- setJacobianWrtParametersTrue(double[][]) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- setJulianDay(int) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the julian day for this SP3 file.
- setJupiterThirdBodyAttraction(ThirdBodyAttraction) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setKKTSolver(AbstractKKTSolver) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPrimalDualMethod
-
Set the KTT solver
- setKKTSolver(AbstractKKTSolver) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.NewtonLEConstrainedFSP
-
Set the ktt solver
- setKKTSolver(AbstractKKTSolver) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.NewtonLEConstrainedISP
-
Set the ktt solver
- setKurtosisImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the kurtosis.
- setLastNameRecord(String) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Setter for the name of the last name record read.
- setLastSummaryRecord(double[]) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Store the content of the last summary record into the state.
- setLb(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the lower bounds
- setLb(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the lower bounds
- setLenseThirringRelativisticEffect(LenseThirringRelativisticEffect) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setLLHCoordinatesSystem(LLHCoordinatesSystem) - Method in class fr.cnes.sirius.patrius.bodies.AbstractBodyShape
-
Setter for the LLH coordinates system to be used by the computed
BodyPoint.
- setLLHCoordinatesSystem(LLHCoordinatesSystem) - Method in interface fr.cnes.sirius.patrius.bodies.BodyShape
-
Setter for the LLH coordinates system to be used by the computed
BodyPoint.
- setLowerBound(double) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the lower bound of the re-use interval.
- setLowerEndPoint(IntervalEndpointType) - Method in class fr.cnes.sirius.patrius.math.interval.AbstractInterval
-
- setLowestFile(int) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the lowest file number searched during the construction of the segment list.
- setLPOptimizationRequest(LPOptimizationRequest) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Set the linear problem optimization request
- setLPOptimizationResponse(LPOptimizationResponse) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Set the linear problem optimization response
- setLst(double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for lst.
- setMainFieldCoefficients(int, int, double, double) - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Setter for the given main field coefficients.
- setMainFieldOfView(IFieldOfView) - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
Sets the main field of view of this sensor
- setMainShape(CrossSectionProvider) - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Set the main vehicle shape.
- setMainTarget(PVCoordinatesProvider, ApparentRadiusProvider) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Sets the main target of the sensor property.
- setMainTarget(PVCoordinatesProvider, ApparentRadiusProvider) - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
Sets the main target of the sensor
- setMapper(SecondOrderStateMapper) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.cowell.CowellIntegrator
-
Set second order / first order state mapper.
- setMarsThirdBodyAttraction(ThirdBodyAttraction) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setMass(double) - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Sets the mass of the object.
- setMassCenter(Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
-
Sets the mass center.
- setMassDerivativeZero(String) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
-
Set mass derivative to zero.
- setMassDerivativeZero(String) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
-
Set mass derivative to zero.
- setMassDerivativeZero(String) - Method in class fr.cnes.sirius.patrius.assembly.models.MassModel
-
Set mass derivative to zero.
- setMassDerivativeZero() - Method in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
-
Set the flow rate to zero.
- setMassDerivativeZero(String) - Method in interface fr.cnes.sirius.patrius.propagation.MassProvider
-
Set mass derivative to zero.
- setMassDerivativeZero(String) - Method in class fr.cnes.sirius.patrius.propagation.SimpleMassModel
-
Set mass derivative to zero.
- setMassProviderEquation(MassProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Add additional equations associated with the mass provider.
- setMassProviderEquation(MassProvider) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Add additional equations associated with the mass provider.
- setMasterMode(double, PatriusFixedStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Set the propagator to master mode with fixed steps.
- setMasterMode(PatriusStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Set the propagator to master mode with variable steps.
- setMasterMode(double, MultiPatriusFixedStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Set the propagator to master mode with fixed steps.
- setMasterMode(MultiPatriusStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Set the propagator to master mode with variable steps.
- setMasterMode(double, MultiPatriusFixedStepHandler) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Set the propagator to master mode with fixed steps.
- setMasterMode(MultiPatriusStepHandler) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Set the propagator to master mode with variable steps.
- setMasterMode(double, MultiPatriusFixedStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set the propagator to master mode with fixed steps.
- setMasterMode(MultiPatriusStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set the propagator to master mode with variable steps.
- setMasterMode(double, PatriusFixedStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Set the propagator to master mode with fixed steps.
- setMasterMode(PatriusStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Set the propagator to master mode with variable steps.
- setMasterMode(double, PatriusFixedStepHandler) - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Set the propagator to master mode with fixed steps.
- setMasterMode(PatriusStepHandler) - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Set the propagator to master mode with variable steps.
- setMasterMode(double, PatriusFixedStepHandler) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set the propagator to master mode with fixed steps.
- setMasterMode(PatriusStepHandler) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set the propagator to master mode with variable steps.
- setMathLibrary(MathLibrary) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Set Math library.
- setMathLibrary(MathLibraryType) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Set Math library using predefined values.
- setMaxApparentRadiusSteps(int) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Setter for the maximum number of steps in the while loop of
BodyShape#getApparentRadius(PVCoordinatesProvider, AbsoluteDate, PVCoordinatesProvider, PropagationDelayType)
method.
- setMaxCheckInterval(double) - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
Setter for the max check interval.
- setMaxDegree(int) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
Set max degree
- setMaxEvals(int) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierDecompositionEngine
-
Set the maximum evaluations allowed for the integrator.
- setMaxEvaluations(int) - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Set the maximal number of differential equations function evaluations.
- setMaxEvaluations(int) - Method in interface fr.cnes.sirius.patrius.math.ode.ODEIntegrator
-
Set the maximal number of differential equations function evaluations.
- setMaxGrowth(double) - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Set the maximal growth factor for stepsize control.
- setMaxGrowth(double) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Set the maximal growth factor for stepsize control.
- setMaximalCount(int) - Method in class fr.cnes.sirius.patrius.math.util.Incrementor
-
Sets the upper limit for the counter.
- setMaxImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the maximum.
- setMaxImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the maximum.
- setMaxImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Sets the implementation for the maximum.
- setMaxImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the maximum.
- setMaxImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the maximum.
- setMaxIter(int) - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
Set the maximum number of iterations allowed for the algorithm which searches for the zero of the g function.
- setMaxIteration(int) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the maximum number of iteration in the search algorithm.
- setMaxIterSignalPropagation(int) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Setter for the maximum number of iterations for signal propagation when signal propagation is
taken into account.
- setMaxIterSignalPropagation(int) - Method in class fr.cnes.sirius.patrius.bodies.AbstractEllipsoidBodyShape
-
Set the maximum number of iterations for signal propagation when signal propagation is taken into account.
- setMaxIterSignalPropagation(int) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Setter for the maximum number of iterations for signal propagation when signal propagation is taken into account.
- setMaxIterSignalPropagation(int) - Method in class fr.cnes.sirius.patrius.forces.radiation.LightingRatio
-
Setter for the maximum number of iterations for signal propagation when signal propagation is taken into account.
- setMaxIterSignalPropagation(int) - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Setter for the maximum number of iterations for signal propagation when signal propagation is taken into account.
- setMeanArea(Double) - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Sets the mean drag area of the object.
- setMeanImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the mean.
- setMeanImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the mean.
- setMeanImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Sets the implementation for the mean.
- setMeanImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the mean.
- setMeanImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the mean.
- setMinImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the minimum.
- setMinImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the minimum.
- setMinImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Sets the implementation for the minimum.
- setMinImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the minimum.
- setMinImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the minimum.
- setMinReduction(double) - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Set the minimal reduction factor for stepsize control.
- setMinReduction(double) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Set the minimal reduction factor for stepsize control.
- setMode(int) - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
Sets the data generation mode.
- setModel(TDBModel) - Static method in class fr.cnes.sirius.patrius.time.TDBScale
-
Set the TDB model.
- setMODPrecession(MODPrecessionModel) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationBuilder
-
Setter for MOD precession provider in the builder.
- setMODPrecessionModel(MODPrecessionModel) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Set the MOD precession model.
- setMoonThirdBodyAttraction(ThirdBodyAttraction) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setMu(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractGravityModel
-
Set the central attraction coefficient.
- setMu(double) - Method in interface fr.cnes.sirius.patrius.forces.gravity.GravityModel
-
Set the central attraction coefficient.
- setMu(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.grid.GridGravityModel
-
Set the central attraction coefficient.
- setMu(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
- setMu(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the calibration parameter for line search
- setMu(double) - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
Sets the
mean used in data generation.
- setMu(double) - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
Allows to change the value of the gravitational parameter.
- setMultiplicativeFactor(double) - Method in class fr.cnes.sirius.patrius.assembly.vehicle.VehicleSurfaceModel
-
Set the multiplicative factor applied to the reference surface.
- setMultiplicativeFactor(double) - Method in class fr.cnes.sirius.patrius.forces.gravity.AbstractBodyAttraction
-
Set the multiplicative factor.
- setMultiplicators(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationResponse
-
Set the Lagrangian multipliers.
- setMutability(boolean) - Method in class fr.cnes.sirius.patrius.math.parameter.ParameterDescriptor
-
Enables or disables the mutability of this parameter descriptor.
- setName(String) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
Set frame name.
- setName(String) - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Sets the name of the object.
- setNatureConverter(List<StelaForceModel>) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Set the force models to be used in the mean <=> osculating converter.
- setNewtonThreshold(double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Ellipsoid
-
Setter for Newton algorithm threshold used to compute closest point and distance to the ellipsoid.
- setNOfSlackVariables(int) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Set the number of slack variables
- setNoIntercept(boolean) - Method in class fr.cnes.sirius.patrius.math.stat.regression.AbstractMultipleLinearRegression
-
- setNotFeasibleInitialPoint(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set a not-feasible starting point for the minimum search
- setNumberOfEpochs(int) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the number of epochs as contained in the SP3 file.
- setNumElements(int) - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
This function allows you to control the number of elements contained
in this array, and can be used to "throw out" the last n values in an
array.
- setNumeratorFormat(NumberFormat) - Method in class fr.cnes.sirius.patrius.math.fraction.AbstractFormat
-
Modify the numerator format.
- setOcculted(PVCoordinatesProvider) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Set the occulted body.
- setOceanTides(OceanTides) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setOptimizationRequest(OptimizationRequest) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Set optimization request
- setOptimizationRequest(OptimizationRequest) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.JOptimizer
-
Set the optimization request
- setOptimizationRequest(OptimizationRequest) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Set the optimization request
- setOptimizationResponse(OptimizationResponse) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.AbstractLPOptimizationRequestHandler
-
Set optimization response
- setOptimizationResponse(OptimizationResponse) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
Set the optimization response
- setOrbit(Orbit) - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
Allows to change the orbit.
- setOrbitFrame(Frame) - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Set propagation frame.
- setOrbitFrame(Frame) - Method in interface fr.cnes.sirius.patrius.propagation.BoundedPropagator
-
Set propagation frame.
- setOrbitFrame(Frame) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Set propagation frame.
- setOrbitFrame(Frame) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set propagation frame.
- setOrbitTolerance(double[], double[], String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set the orbit tolerance of a defined state.
- setOrbitType(SP3File.SP3OrbitType) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
- setOrder(int) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.FourierDecompositionEngine
-
- setOrderControl(int, double, double) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the order control parameters.
- setOrientation(CelestialBodyOrientation) - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Setter for a celestial body orientation to define the body frames.
- setOrientation(CelestialBodyOrientation) - Method in class fr.cnes.sirius.patrius.bodies.AbstractIAUCelestialBody
-
Set a celestial body IAU orientation to define the body frames.
- setOrientation(CelestialBodyOrientation) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Setter for a celestial body orientation to define the body frames.
- setOrientation(CelestialBodyOrientation) - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Setter for a celestial body orientation to define the body frames.
- setOriginOffset(double) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Line
-
Set the offset of the origin.
- setParameter(String, double) - Method in interface fr.cnes.sirius.patrius.math.ode.ParameterizedODE
-
Set the value for a given parameter.
- setParameterizedODE(ParameterizedODE) - Method in class fr.cnes.sirius.patrius.math.ode.JacobianMatrices
-
Set a parameter Jacobian provider.
- setParameterStep(String, double) - Method in class fr.cnes.sirius.patrius.math.ode.JacobianMatrices
-
Set the step associated to a parameter in order to compute by finite
difference the Jacobian matrix.
- setPartName(String) - Method in class fr.cnes.sirius.patrius.assembly.properties.PropulsiveProperty
-
Setter for the part name owning the property.
- setPartName(String) - Method in class fr.cnes.sirius.patrius.assembly.properties.TankProperty
-
Setter for the part name owning the property.
- setPastCycleFilePaths(List<String>) - Static method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCycleSolarActivityProperties
-
Set the past cycles file paths
- setPatriusCompatibilityMode(PatriusConfiguration.PatriusVersionCompatibility) - Static method in class fr.cnes.sirius.patrius.utils.PatriusConfiguration
-
- setPercentileImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
- setPeriodicComputationMethod(VariablePotentialCoefficientsSet.PeriodicComputationMethod) - Static method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
-
Setter for periodicComputationMethod
- setPoint(int, PointValuePair) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Store a new point at location index.
- setPoints(PointValuePair[]) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Replace all points.
- setPolarMotion(PolarMotion) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationBuilder
-
Setter for polar motion provider in the builder.
- setPolarMotionModel(PolarMotion) - Method in class fr.cnes.sirius.patrius.frames.configuration.FramesConfigurationImplementation
-
Set the polar motion model.
- setPolynomialOrder(int) - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
- setPopulationLimit(int) - Method in class fr.cnes.sirius.patrius.math.genetics.ListPopulation
-
Sets the maximal population size.
- setPresolvingDisabled(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set if LP presolving should be disabled
- setPressure(double) - Method in class fr.cnes.sirius.patrius.events.detectors.ApparentElevationDetector
-
Set the local pressure at topocentric frame origin if needed.
- setPreviousDescriptor(double[]) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the previous descriptor returned.
- setPreviousHandle(int) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the previous handle returned.
- setPreviousIndex(int) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.AbstractBoundedPVProvider
-
Setter for the previous search index
- setPreviousSegmentId(String) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the previous segment identifier returned.
- setPrimaryState(double[]) - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Set primary part of the current state.
- setPrintFunction(SerializableFunction<T, String>) - Method in class fr.cnes.sirius.patrius.math.parameter.FieldDescriptor
-
Sets the function to use when converting field values to strings.
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractEclipseDetector
-
Setter for the propagation delay computation type.
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.AbstractSignalPropagationDetector
-
Setter for the propagation delay computation type.
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.ApparentElevationDetector
-
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.BetaAngleDetector
-
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.SensorVisibilityDetector
-
Setter for the propagation delay computation type.
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Setter for the propagation delay computation type.
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.TargetInFieldOfViewDetector
-
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.events.detectors.VisibilityFromStationDetector
-
Setter for the propagation delay computation type.
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.forces.radiation.LightingRatio
-
Setter for the propagation delay computation type.
- setPropagationDelayType(AbstractSignalPropagationDetector.PropagationDelayType, Frame) - Method in class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Setter for the propagation delay computation type.
- setProvider(IJacobiansParameterizable) - Method in class fr.cnes.sirius.patrius.propagation.numerical.ParameterConfiguration
-
Set the povider handling this parameter.
- setQuantile(double) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.rank.Percentile
-
Sets the value of the quantile field (determines what percentile is
computed when evaluate() is called with no quantile argument).
- setRadiativeProperties(AssemblyBuilder, String, double) - Method in class fr.cnes.sirius.patrius.assembly.vehicle.RadiativeProperties
-
Set radiative properties.
- setRadiativeProperties(double, double, double, double, double, double) - Method in class fr.cnes.sirius.patrius.assembly.Vehicle
-
Set radiative properties.
- setRandomGenerator(RandomGenerator) - Static method in class fr.cnes.sirius.patrius.math.genetics.GeneticAlgorithm
-
Set the (static) random generator.
- setReadCompleted(boolean) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
- setReadCompleted(boolean) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivityReader
-
- setRecnoCurrSummary(int) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.DafState
-
Set the current summary record of the DAF.
- setRediffusedRadiationPressure(RediffusedRadiationPressure) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setReference(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.numerical.ModeHandler
-
Define new reference date.
- setReference(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiEphemerisModeHandler
-
Define new reference date.
- setReference(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.numerical.multi.MultiModeHandler
-
Define new reference date.
- setReference(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.sampling.AdaptedStepHandler
-
Define new reference date.
- setReference(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
-
Define new reference date.
- setReferenceAxis(Vector3D[]) - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
-
Sets the reference axis
- setReferential(Frame) - Method in class fr.cnes.sirius.patrius.frames.Frame
-
- setReflectingArea(Double) - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Sets the reflecting area of the object.
- setReflectionCoef(Double) - Method in class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Sets the reflection coefficient of the object.
- setRescalingDisabled(boolean) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set if the matrix rescaling should be disabled (true) or not (false)
Rescaling is involved in LP presolving and in the solution of the KKT
systems associated with the problem.
- setReturnCode(int) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationResponse
-
Set the return code (succes, warn or failed)
- setReuseExpense(int) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the expense of the re-use interval.
- setRoundingMode(DfpField.RoundingMode) - Method in class fr.cnes.sirius.patrius.math.dfp.DfpField
-
Set the rounding mode.
- setRoundingMode(RoundingMode) - Method in class fr.cnes.sirius.patrius.math.util.BigReal
-
Sets the rounding mode for decimal divisions.
- setRow(int, T[]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Set the entries in row number row as a row matrix.
- setRow(int, double[]) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Replaces the entries of a given row with the entries of the specified data array.
- setRow(int, double[]) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Replaces the entries of a given row with the entries of the specified data array.
- setRow(int, T[]) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Set the entries in row number row as a row matrix.
- setRow(int, double[]) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Replaces the entries of a given row with the entries of the specified data array.
- setRow(int, double[]) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Replaces the entries of a given row with the entries of the specified data array.
- setRow(int, T[]) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Set the entries in row number row as a row matrix.
- setRow(int, double[]) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Replaces the entries of a given row with the entries of the specified data array.
- setRowMatrix(int, FieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Set the entries in row number row as a row matrix.
- setRowMatrix(int, RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Replaces the entries of a given row with the entries of the specified row matrix.
- setRowMatrix(int, RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Replaces the entries of a given row with the entries of the specified row matrix.
- setRowMatrix(int, FieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Set the entries in row number row as a row matrix.
- setRowMatrix(int, BlockFieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Sets the entries in row number row as a row matrix.
- setRowMatrix(int, RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Replaces the entries of a given row with the entries of the specified row matrix.
- setRowMatrix(int, BlockRealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Sets the entries in row number row as a row matrix.
- setRowMatrix(int, RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Replaces the entries of a given row with the entries of the specified row matrix.
- setRowMatrix(int, FieldMatrix<T>) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Set the entries in row number row as a row matrix.
- setRowMatrix(int, RealMatrix) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Replaces the entries of a given row with the entries of the specified row matrix.
- setRowVector(int, FieldVector<T>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Set the entries in row number row as a vector.
- setRowVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Replaces the entries of a given row with the entries of the specified vector.
- setRowVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Replaces the entries of a given row with the entries of the specified vector.
- setRowVector(int, FieldVector<T>) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Set the entries in row number row as a vector.
- setRowVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Replaces the entries of a given row with the entries of the specified vector.
- setRowVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Replaces the entries of a given row with the entries of the specified vector.
- setRowVector(int, FieldVector<T>) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Set the entries in row number row as a vector.
- setRowVector(int, RealVector) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Replaces the entries of a given row with the entries of the specified vector.
- setS(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AugmentedKKTSolver
-
Set a value to s
- setSafety(double) - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Set the safety factor for stepsize control.
- setSafety(double) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Set the safety factor for stepsize control.
- setSatelliteId(String) - Method in class fr.cnes.sirius.patrius.files.general.SatelliteInformation
-
Set the id of this satellite.
- setScale(int) - Method in class fr.cnes.sirius.patrius.math.util.BigReal
-
Sets the scale for division operations.
- setSchwarzschildRelativisticEffect(SchwarzschildRelativisticEffect) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setSearchMethod(TimeStampedInterpolableEphemeris.SearchMethod) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.PVEphemeris
-
Setter for the search method.
- setSearchMethod(TimeStampedInterpolableEphemeris.SearchMethod) - Method in class fr.cnes.sirius.patrius.time.interpolation.TimeStampedInterpolableEphemeris
-
Setter for the search method.
- setSec(double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Input
-
Setter for doy.
- setSecondaryState(int, double[]) - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Set secondary part of the current state.
- setSecondCovarianceMatrix(RealMatrix, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.analytical.covariance.CovarianceInterpolation
-
Allows to change the CovarianceMatrix standing for the upper bound of the
interpolation interval, associated with t2.
- setSecondsOfWeek(double) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the seconds of the GPS week for this SP3 file.
- setSecularVariationCoefficients(int, int, double, double) - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Setter for the given secular variation coefficients.
- setSecureAlgorithm(String, String) - Method in class fr.cnes.sirius.patrius.math.random.RandomDataGenerator
-
Sets the PRNG algorithm for the underlying SecureRandom instance using
the Security Provider API.
- setSeed(int) - Method in class fr.cnes.sirius.patrius.math.random.AbstractRandomGenerator
-
Sets the seed of the underlying random number generator using an int seed.
- setSeed(int[]) - Method in class fr.cnes.sirius.patrius.math.random.AbstractRandomGenerator
-
Sets the seed of the underlying random number generator using an int array seed.
- setSeed(long) - Method in class fr.cnes.sirius.patrius.math.random.AbstractRandomGenerator
-
Sets the seed of the underlying random number generator using a long seed.
- setSeed(int) - Method in class fr.cnes.sirius.patrius.math.random.AbstractWell
-
Reinitialize the generator as if just built with the given int seed.
- setSeed(int[]) - Method in class fr.cnes.sirius.patrius.math.random.AbstractWell
-
Reinitialize the generator as if just built with the given int array seed.
- setSeed(long) - Method in class fr.cnes.sirius.patrius.math.random.AbstractWell
-
Reinitialize the generator as if just built with the given long seed.
- setSeed(int) - Method in class fr.cnes.sirius.patrius.math.random.BitsStreamGenerator
-
Sets the seed of the underlying random number generator using an int seed.
- setSeed(int[]) - Method in class fr.cnes.sirius.patrius.math.random.BitsStreamGenerator
-
Sets the seed of the underlying random number generator using an int array seed.
- setSeed(long) - Method in class fr.cnes.sirius.patrius.math.random.BitsStreamGenerator
-
Sets the seed of the underlying random number generator using a long seed.
- setSeed(int) - Method in class fr.cnes.sirius.patrius.math.random.ISAACRandom
-
Sets the seed of the underlying random number generator using an int seed.
- setSeed(long) - Method in class fr.cnes.sirius.patrius.math.random.ISAACRandom
-
Sets the seed of the underlying random number generator using a long seed.
- setSeed(int[]) - Method in class fr.cnes.sirius.patrius.math.random.ISAACRandom
-
Sets the seed of the underlying random number generator using an int array seed.
- setSeed(int) - Method in class fr.cnes.sirius.patrius.math.random.JDKRandomGenerator
-
Sets the seed of the underlying random number generator using an int seed.
- setSeed(int[]) - Method in class fr.cnes.sirius.patrius.math.random.JDKRandomGenerator
-
Sets the seed of the underlying random number generator using an int array seed.
- setSeed(int) - Method in class fr.cnes.sirius.patrius.math.random.MersenneTwister
-
Reinitialize the generator as if just built with the given int seed.
- setSeed(int[]) - Method in class fr.cnes.sirius.patrius.math.random.MersenneTwister
-
Reinitialize the generator as if just built with the given int array seed.
- setSeed(long) - Method in class fr.cnes.sirius.patrius.math.random.MersenneTwister
-
Reinitialize the generator as if just built with the given long seed.
- setSeed(int) - Method in class fr.cnes.sirius.patrius.math.random.RandomAdaptor
-
Sets the seed of the underlying random number generator using an int seed.
- setSeed(int[]) - Method in class fr.cnes.sirius.patrius.math.random.RandomAdaptor
-
Sets the seed of the underlying random number generator using an int array seed.
- setSeed(long) - Method in class fr.cnes.sirius.patrius.math.random.RandomAdaptor
-
Sets the seed of the underlying random number generator using a long seed.
- setSeed(int) - Method in interface fr.cnes.sirius.patrius.math.random.RandomGenerator
-
Sets the seed of the underlying random number generator using an int seed.
- setSeed(int[]) - Method in interface fr.cnes.sirius.patrius.math.random.RandomGenerator
-
Sets the seed of the underlying random number generator using an int array seed.
- setSeed(long) - Method in interface fr.cnes.sirius.patrius.math.random.RandomGenerator
-
Sets the seed of the underlying random number generator using a long seed.
- setSeed(int) - Method in class fr.cnes.sirius.patrius.math.random.SynchronizedRandomGenerator
-
Sets the seed of the underlying random number generator using an int seed.
- setSeed(int[]) - Method in class fr.cnes.sirius.patrius.math.random.SynchronizedRandomGenerator
-
Sets the seed of the underlying random number generator using an int array seed.
- setSeed(long) - Method in class fr.cnes.sirius.patrius.math.random.SynchronizedRandomGenerator
-
Sets the seed of the underlying random number generator using a long seed.
- setShape(BodyShape) - Method in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Setter for a geometric shape to the body.
- setShape(BodyShape) - Method in interface fr.cnes.sirius.patrius.bodies.CelestialBody
-
Setter for a geometric shape to the body.
- setShape(BodyShape) - Method in class fr.cnes.sirius.patrius.bodies.Earth
-
Setter for a geometric shape to the body.
- setSigma(double) - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
- setSize(double) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Set the size of the instance.
- setSkewnessImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the skewness.
- setSlaveMode() - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Set the propagator to slave mode.
- setSlaveMode() - Method in class fr.cnes.sirius.patrius.propagation.analytical.multi.MultiAnalyticalPropagator
-
Set the propagator to slave mode.
- setSlaveMode() - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Set the propagator to slave mode.
- setSlaveMode() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Set the propagator to slave mode.
- setSlaveMode() - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Set the propagator to slave mode.
- setSlaveMode() - Method in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Set the propagator to slave mode.
- setSlaveMode() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set the propagator to slave mode.
- setSoftCurrentTime(double) - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Restrict step range to a limited part of the global step.
- setSoftPreviousTime(double) - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Restrict step range to a limited part of the global step.
- setSolarActivityDataProvider(SolarActivityDataProvider) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setSolarFluxMap(NavigableMap<AbsoluteDate, Double>) - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Set the solar flux map.
- setSolarRadiationPressure(SolarRadiationPressure) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setSolution(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationResponse
-
Set the solution
- setSPICEJ2000Convention(BSPEphemerisLoader.SpiceJ2000ConventionEnum) - Method in class fr.cnes.sirius.patrius.bodies.bsp.BSPEphemerisLoader
-
Setter for the Spice J2000 convention.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeLaw
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.AbstractGroundPointingWrapper
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeLawLeg
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudeLegLaw
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in interface fr.cnes.sirius.patrius.attitudes.AttitudeProvider
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.AttitudesSequence
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.ConstantSpinSlew
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.LofOffsetPointing
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAngularVelocitiesAttitudeProfile
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfilesSequence
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialProfile
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionHarmonicProfile
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionPolynomialProfile
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.RelativeTabulatedAttitudeLaw
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.RelativeTabulatedAttitudeLeg
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.StrictAttitudeLegsSequence
-
Method to activate spin derivative computation.
- setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Method to activate spin derivative computation.
- setStabilityCheck(boolean, int, int, double) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the stability check controls.
- setStandardLineSeparator(String) - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Setter for the String representing the standard line separator.
- setStartDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.AbstractPropagator
-
Set a start date.
- setStartDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Set a start date.
- setStarterIntegrator(FirstOrderIntegrator) - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Set the starter integrator.
- setStateInitialized(boolean) - Method in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Set the stateInitialized flag.
- setSteps(double) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AbstractPartialDerivativesEquations
-
Set the step for finite differences with respect to spacecraft position.
- setStepSizeControl(double, double, double, double, boolean) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the adaptive step size control parameters.
- setStepSizeControl(double, double, double[], double[], boolean) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the adaptive step size control parameters.
- setStoreTimeDerivatives(boolean) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Setter for flag indicating if time derivatives dE'/dt must be stored.
- setStringAlign(StringTablePrinter.StringAlign) - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Setter for the text alignment mode (
RIGHT by default).
- setSubMatrix(T[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Replace the submatrix starting at (row, column) using data in the
input subMatrix array.
- setSubMatrix(double[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Replaces part of the matrix with a given submatrix, starting at the specified row and column.
- setSubMatrix(T[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Replace the submatrix starting at (row, column) using data in the
input subMatrix array.
- setSubMatrix(double[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Replaces part of the matrix with a given submatrix, starting at the specified row and column.
- setSubMatrix(double[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Replaces part of the matrix with a given submatrix, starting at the specified row and column.
- setSubMatrix(double[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricPositiveMatrix
-
Replaces part of the matrix with a given submatrix, starting at the specified row and column.
- setSubMatrix(T[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Replace the submatrix starting at (row, column) using data in the
input subMatrix array.
- setSubMatrix(double[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Replaces part of the matrix with a given submatrix, starting at the specified row and column.
- setSubMatrix(double[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Replaces part of the matrix with a given submatrix, starting at the specified row and column.
- setSubMatrix(double[][], int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Replaces part of the matrix with a given submatrix, starting at the specified row and column.
- setSubMatrix(T[][], int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Replace the submatrix starting at (row, column) using data in the
input subMatrix array.
- setSubMatrix(double[][], int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Replaces part of the matrix with a given submatrix, starting at the specified row and column.
- setSubVector(int, FieldVector<T>) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Set a set of consecutive elements.
- setSubVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Set a sequence of consecutive elements.
- setSubVector(int, double[]) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Set a set of consecutive elements.
- setSubVector(int, FieldVector<T>) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldVector
-
Set a set of consecutive elements.
- setSubVector(int, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Set a sequence of consecutive elements.
- setSumImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the sum.
- setSumImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the Sum.
- setSumImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Sets the implementation for the Sum.
- setSumImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the Sum.
- setSumImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the Sum.
- setSumLogImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.GeometricMean
-
Sets the implementation for the sum of logs.
- setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the sum of logs.
- setSumLogImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Sets the implementation for the sum of logs.
- setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the sum of logs.
- setSumLogImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the sum of logs.
- setSumsqImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the sum of squares.
- setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.MultivariateSummaryStatistics
-
Sets the implementation for the sum of squares.
- setSumsqImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Sets the implementation for the sum of squares.
- setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Sets the implementation for the sum of squares.
- setSumsqImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the sum of squares.
- setSun(PVCoordinatesProvider) - Method in class fr.cnes.sirius.patrius.events.detectors.NadirSolarIncidenceDetector
-
- setSunThirdBodyAttraction(ThirdBodyAttraction) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setSwitches(int, int) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Flags
-
Setter for a specific element of the switches array.
- setSwitches(int[]) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.Flags
-
Setter for switches.
- setTemperature(double) - Method in class fr.cnes.sirius.patrius.events.detectors.ApparentElevationDetector
-
Set the local temperature at topocentric frame origin if needed.
- setTerrestrialTides(TerrestrialTides) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setThreshold(double) - Method in class fr.cnes.sirius.patrius.bodies.mesh.FacetBodyShape
-
Setter for the threshold for apparent radius determination convergence.
- setThreshold(double) - Method in class fr.cnes.sirius.patrius.propagation.analytical.AbstractLyddanePropagator
-
Setter for relative convergence threshold for osculating to mean algorithm.
- setThreshold(double) - Static method in class fr.cnes.sirius.patrius.propagation.analytical.EcksteinHechlerPropagator
-
Setter for osculating to mean conversion relative convergence threshold.
- setThreshold(double) - Method in class fr.cnes.sirius.patrius.propagation.analytical.LiuMeanOsculatingConverter
-
Setter for relative convergence threshold for osculating to mean algorithm.
- setThreshold(double) - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DOrbitModel
-
- setThreshold(double) - Method in class fr.cnes.sirius.patrius.propagation.analytical.twod.Analytical2DPropagator
-
- setThreshold(double) - Static method in class fr.cnes.sirius.patrius.stela.orbits.OrbitNatureConverter
-
Setter for osculating to mean conversion relative convergence threshold.
- setThresholdDegraded(double) - Static method in class fr.cnes.sirius.patrius.stela.orbits.OrbitNatureConverter
-
Setter for osculating to mean conversion second relative convergence threshold.
- setTime(double) - Method in class fr.cnes.sirius.patrius.math.ode.ExpandableStatefulODE
-
Set current time.
- setTimeInterval(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.TabulatedAttitude
-
Return a new law with the specified interval.
- setTimeout(int) - Method in class fr.cnes.sirius.patrius.data.NetworkCrawler
-
Set the timeout for connection.
- setTimeSystem(OrbitFile.TimeSystem) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the time system used in this SP3 file.
- SETTING - Static variable in class fr.cnes.sirius.patrius.events.detectors.VisibilityFromStationDetector
-
Flag for setting detection (slopeSelection = 1).
- setTitle(String) - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Optionally, add a centered title (will be displayed before the header).
- setTolerance(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the tolerance for the minimum value.
- setToleranceFeas(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the tolerance for the constraints satisfaction.
- setToleranceInnerStep(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the tolerance for inner iterations in the barrier-method.
- setToleranceKKT(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequest
-
Set the acceptable tolerance for KKT system resolution
- setToleranceKKT(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Acceptable tolerance for system resolution.
- setTolerances(double[], double[]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.AdditionalEquationsAndTolerances
-
Set tolerances (no size check).
- setTransform(Transform) - Method in class fr.cnes.sirius.patrius.frames.UpdatableFrame
-
Update the transform from the parent frame to the instance.
- setTransMatComputationFlag(boolean) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAtmosphericDrag
-
Setter for the switch indicating whether the drag term of the transition matrix has to be
computed.
- setType(SP3File.SP3FileType) - Method in class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Set the file type for this SP3 file.
- setUb(double[]) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the upper bounds
- setUb(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the upper bounds
- setup(int, UnivariateFunction, double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.BaseAbstractUnivariateIntegrator
-
Prepare for computation.
- setup(int, BivariateFunction, double, double, double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.bivariate.DelegatedBivariateIntegrator
-
Prepares for computation.
- setup(int, LebedevFunction, LebedevGrid) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.sphere.lebedev.LebedevIntegrator
-
Setup.
- setup(int, PolynomialFunction, double, double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.AbstractPolynomialSolver
-
Prepare for computation.
- setup(int, UnivariateDifferentiableFunction, double, double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.AbstractUnivariateDifferentiableSolver
-
Prepare for computation.
- setup(int, F, double, double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Prepare for computation.
- setUpEventDetector(EventDetector, Map<String, MultiAttitudeProvider>, Map<String, MultiAttitudeProvider>, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Wrap an Orekit event detector and register it to the integrator.
- setUpEventDetector(MultiEventDetector, Map<String, MultiAttitudeProvider>, Map<String, MultiAttitudeProvider>) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
-
Wrap an Orekit multi-sat event detector and register it to the integrator.
- setUpEventDetector(EventDetector) - Method in class fr.cnes.sirius.patrius.propagation.numerical.NumericalPropagator
-
Wrap an Orekit event detector and register it to the integrator.
- setUpperBound(double) - Method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Setter for the upper bound of the re-use interval.
- setUpperEndPoint(IntervalEndpointType) - Method in class fr.cnes.sirius.patrius.math.interval.AbstractInterval
-
- setValue(String, Object) - Method in class fr.cnes.sirius.patrius.math.exception.util.ExceptionContext
-
Sets the context (key, value) pair.
- setValue(double) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector.Entry
-
Set the value of the entry.
- setValue(double) - Method in class fr.cnes.sirius.patrius.math.parameter.Parameter
-
Sets the parameter value.
- setValuesFileURL(String) - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
- setValuesFileURL(URL) - Method in class fr.cnes.sirius.patrius.math.random.ValueServer
-
- setVarianceDirection(SemiVariance.Direction) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.moment.SemiVariance
-
Sets the variance direction
- setVarianceImpl(UnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
Sets the implementation for the variance.
- setVarianceImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Sets the implementation for the variance.
- setVarianceImpl(StorelessUnivariateStatistic) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Sets the implementation for the variance.
- setVecAbsoluteTolerance(double[]) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the vector of absolute tolerances.
- setVecRelativeTolerance(double[]) - Method in class fr.cnes.sirius.patrius.math.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the vector of relative tolerances.
- setVenusThirdBodyAttraction(ThirdBodyAttraction) - Method in class fr.cnes.sirius.patrius.forces.ForceModelsData
-
- setVerticalLeftSeparator(String) - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Setter for the String representing the vertical separator of the left column.
- setVerticalRightSeparator(String) - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Setter for the String representing the vertical separator of the right column.
- setVerticalSeparator(String) - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Setter for the String representing the vertical separator of the middle columns.
- setWatch(String, int, String[]) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.PoolSpice
-
Add a name to the list of agents to notify whenever a member of a list of kernel variables is updated.
- setWholeFormat(NumberFormat) - Method in class fr.cnes.sirius.patrius.math.fraction.ProperBigFractionFormat
-
Modify the whole format.
- setWholeFormat(NumberFormat) - Method in class fr.cnes.sirius.patrius.math.fraction.ProperFractionFormat
-
Modify the whole format.
- setWindowSize(int) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.DescriptiveStatistics
-
WindowSize controls the number of values that contribute to the
reported statistics.
- setWindowSize(int) - Method in class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
WindowSize controls the number of values that contribute to the
reported statistics.
- setYear(int) - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
Set file year
- setYlb(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the Lagrangian lower bounds for linear constraints (A rows)
- setYub(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the Lagrangian upper bounds for linear constraints (A rows)
- setZeroTolerance(double) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPPresolver
-
Set the value for zero-comparison:
if |a - b| < eps then a - b = 0.
- setZlb(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the Lagrangian upper bounds for linear bounds
- setZub(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.LPOptimizationRequest
-
Set the Lagrangian upper bounds for upper bounds
- SEVEN_POINT_FIVE - Static variable in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
-
Constant 7.5
- SGP - Static variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Identifier for SGP type of ephemeris.
- SGP4 - Static variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Identifier for SGP4 type of ephemeris.
- SGP8 - Static variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLE
-
Identifier for SGP8 type of ephemeris.
- sh - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Intermediate values.
- Shape - Interface in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
Interface for all shapes.
- shift(double[], double) - Static method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialsUtils
-
Compute the coefficients of the polynomial Ps(x) whose values at
point x will be
the same as the those from the
original polynomial P(x) when computed at x + shift.
- shift() - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Shift one step forward.
- shift() - Method in class fr.cnes.sirius.patrius.propagation.sampling.BasicStepInterpolator
-
Shift one step forward.
- shift(double) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Returns the interval with its lower an upper bounds shifted by the specified value.
- shift(double, double) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDateInterval
-
Returns the interval with its lower an upper bounds shifted by the specified values.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.attitudes.Attitude
-
Get a time-shifted attitude.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.covariance.MultiOrbitalCovariance
-
Shifts the orbital covariance in time by a given duration.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.covariance.OrbitalCovariance
-
Shifts the orbital covariance in time by a given duration.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get a time-shifted instance.
- shiftedBy(double, boolean) - Method in class fr.cnes.sirius.patrius.frames.transformations.Transform
-
Get a time-shifted instance.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.orbits.Orbit
-
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.orbits.pvcoordinates.PVCoordinates
-
Get a time-shifted state.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Get a time-shifted state.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Get a time-shifted date.
- shiftedBy(double, TimeScale) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Get a time-shifted date in provided time scale.
- shiftedBy(double, AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.time.AbsoluteDate
-
Shift a date taking into account a limit date which shall not be overpassed by this + dt.
- shiftedBy(double) - Method in interface fr.cnes.sirius.patrius.time.TimeShiftable
-
Get a time-shifted instance.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Get a time-shifted state.
- shiftedBy(double, boolean) - Method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Get a time-shifted state.
- shiftedBy(double, boolean) - Method in class fr.cnes.sirius.patrius.utils.TimeStampedAngularCoordinates
-
Get a time-shifted state.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.utils.TimeStampedAngularCoordinates
-
Get a time-shifted state.
- shiftedBy(double) - Method in class fr.cnes.sirius.patrius.utils.TimeStampedPVCoordinates
-
Get a time-shifted state.
- shiftLeft() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Shift the mantissa left, and adjust the exponent to compensate.
- shiftRight() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Shift the mantissa right, and adjust the exponent to compensate.
- SHM_FILENAME - Static variable in class fr.cnes.sirius.patrius.forces.gravity.potential.GravityFieldFactory
-
Default regular expression for SHM files.
- SHMFormatReader - Class in fr.cnes.sirius.patrius.forces.gravity.potential
-
Reader for the SHM gravity field format.
- SHMFormatReader(String, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.potential.SHMFormatReader
-
Simple constructor.
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.AbstractDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.detectors.CombinedPhenomenaDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.detectors.IntervalOccurrenceDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.detectors.NullMassDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.detectors.NullMassPartDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
- shouldBeRemoved() - Method in interface fr.cnes.sirius.patrius.events.EventDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.MultiAbstractDetector
-
- shouldBeRemoved() - Method in interface fr.cnes.sirius.patrius.events.MultiEventDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.postprocessing.GenericCodingEventDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.postprocessing.MultiGenericCodingEventDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedEventDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedMonoEventDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.utils.AdaptedMultiEventDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.utils.EventShifter
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.utils.OneSatEventDetectorWrapper
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
- shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ImpulseManeuver
-
- shouldBeRemoved() - Method in interface fr.cnes.sirius.patrius.math.ode.events.EventHandler
-
- shouldBeRemovedFlag - Variable in class fr.cnes.sirius.patrius.events.AbstractDetector
-
True if detector should be removed (updated by eventOccured)
- side(Hyperplane<Euclidean1D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.SubOrientedPoint
-
Compute the relative position of the instance with respect
to an hyperplane.
- side(Hyperplane<Euclidean3D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SubPlane
-
Compute the relative position of the instance with respect
to an hyperplane.
- side(Hyperplane<Euclidean2D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.SubLine
-
Compute the relative position of the instance with respect
to an hyperplane.
- side(Hyperplane<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractRegion
-
Compute the relative position of the instance with respect to an
hyperplane.
- side(Hyperplane<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractSubHyperplane
-
Compute the relative position of the instance with respect
to an hyperplane.
- side(Hyperplane<S>) - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.Region
-
Compute the relative position of the instance with respect to an
hyperplane.
- Side - Enum in fr.cnes.sirius.patrius.math.geometry.partitioning
-
Enumerate representing the location of an element with respect to an
hyperplane of a space.
- side(Hyperplane<S>) - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.SubHyperplane
-
Compute the relative position of the instance with respect
to an hyperplane.
- Sigma(double[]) - Constructor for class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.CMAESOptimizer.Sigma
-
- Sigmoid - Class in fr.cnes.sirius.patrius.math.analysis.function
-
- Sigmoid() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Sigmoid
-
Usual sigmoid function, where the lower asymptote is 0 and the higher
asymptote is 1.
- Sigmoid(double, double) - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Sigmoid
-
Sigmoid function.
- Sigmoid.Parametric - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Parametric function where the input array contains the parameters of
the logit function, ordered as follows:
Lower asymptote
Higher asymptote
- sign - Variable in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Sign bit: 1 for positive, -1 for negative.
- SignalPropagationWrapperDetector - Class in fr.cnes.sirius.patrius.events.utils
-
- SignalPropagationWrapperDetector(AbstractSignalPropagationDetector) - Constructor for class fr.cnes.sirius.patrius.events.utils.SignalPropagationWrapperDetector
-
Constructor.
- signum() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Compute the signum of the instance.
- Signum - Class in fr.cnes.sirius.patrius.math.analysis.function
-
signum function.
- Signum() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Signum
-
- signum(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Compute the signum of a number.
- signum(float) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Compute the signum of a number.
- signum(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Compute the signum of a number.
- signum(float) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Compute the signum of a number.
- signum(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Compute the signum of a number.
- signum(float) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Compute the signum of a number.
- signum(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Compute the signum of a number.
- signum(float) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Compute the signum of a number.
- signum(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Compute the signum of a number.
- signum(float) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Compute the signum of a number.
- signum(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Compute the signum of a number.
- signum(float) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Compute the signum of a number.
- signum(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Compute the signum of a number.
- signum(float) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Compute the signum of a number.
- signum() - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Compute the signum of the instance.
- signum(double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Compute the signum of a number.
- signum(float) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Compute the signum of a number.
- signum(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Compute the signum of a number.
- signum(float) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Compute the signum of a number.
- SimpleAdditionalStateProvider - Class in fr.cnes.sirius.patrius.propagation
-
This class is a simple implementation of additionalStateProvider.
- SimpleAdditionalStateProvider(String, AbsoluteDate[], double[][], ISearchIndex) - Constructor for class fr.cnes.sirius.patrius.propagation.SimpleAdditionalStateProvider
-
Creates an instance of SimpleAdditionalStateProvider from a name describing
the additional state double table, a table of dates, and a table of additional states
associated to these dates.
- SimpleBounds - Class in fr.cnes.sirius.patrius.math.optim
-
Simple optimization constraints: lower and upper bounds.
- SimpleBounds(double[], double[]) - Constructor for class fr.cnes.sirius.patrius.math.optim.SimpleBounds
-
- SimpleExponentialAtmosphere - Class in fr.cnes.sirius.patrius.forces.atmospheres
-
Simple exponential atmospheric model.
- SimpleExponentialAtmosphere(EllipsoidBodyShape, double, double, double) - Constructor for class fr.cnes.sirius.patrius.forces.atmospheres.SimpleExponentialAtmosphere
-
Create an exponential atmosphere.
- SimpleMassModel - Class in fr.cnes.sirius.patrius.propagation
-
- SimpleMassModel() - Constructor for class fr.cnes.sirius.patrius.propagation.SimpleMassModel
-
- SimpleMassModel(double, String) - Constructor for class fr.cnes.sirius.patrius.propagation.SimpleMassModel
-
Constructor.
- SimplePointChecker<T extends Pair<double[],? extends Object>> - Class in fr.cnes.sirius.patrius.math.optim
-
- SimplePointChecker(double, double) - Constructor for class fr.cnes.sirius.patrius.math.optim.SimplePointChecker
-
Build an instance with specified thresholds.
- SimplePointChecker(double, double, int) - Constructor for class fr.cnes.sirius.patrius.math.optim.SimplePointChecker
-
Builds an instance with specified thresholds.
- SimpleRegression - Class in fr.cnes.sirius.patrius.math.stat.regression
-
Estimates an ordinary least squares regression model
with one independent variable.
- SimpleRegression() - Constructor for class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Create an empty SimpleRegression instance
- SimpleRegression(boolean) - Constructor for class fr.cnes.sirius.patrius.math.stat.regression.SimpleRegression
-
Create a SimpleRegression instance, specifying whether or not to estimate
an intercept.
- SimpleUnivariateValueChecker - Class in fr.cnes.sirius.patrius.math.optim.univariate
-
- SimpleUnivariateValueChecker(double, double) - Constructor for class fr.cnes.sirius.patrius.math.optim.univariate.SimpleUnivariateValueChecker
-
Build an instance with specified thresholds.
- SimpleUnivariateValueChecker(double, double, int) - Constructor for class fr.cnes.sirius.patrius.math.optim.univariate.SimpleUnivariateValueChecker
-
Builds an instance with specified thresholds.
- SimpleValueChecker - Class in fr.cnes.sirius.patrius.math.optim
-
Simple implementation of the
ConvergenceChecker interface using
only objective function values.
- SimpleValueChecker(double, double) - Constructor for class fr.cnes.sirius.patrius.math.optim.SimpleValueChecker
-
Build an instance with specified thresholds.
- SimpleValueChecker(double, double, int) - Constructor for class fr.cnes.sirius.patrius.math.optim.SimpleValueChecker
-
Builds an instance with specified thresholds.
- SimpleVectorValueChecker - Class in fr.cnes.sirius.patrius.math.optim
-
Simple implementation of the
ConvergenceChecker interface using
only objective function values.
- SimpleVectorValueChecker(double, double) - Constructor for class fr.cnes.sirius.patrius.math.optim.SimpleVectorValueChecker
-
Build an instance with specified thresholds.
- SimpleVectorValueChecker(double, double, int) - Constructor for class fr.cnes.sirius.patrius.math.optim.SimpleVectorValueChecker
-
Builds an instance with specified tolerance thresholds and
iteration count.
- SimplexOptimizer - Class in fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv
-
This class implements simplex-based direct search optimization.
- SimplexOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
- SimplexOptimizer(double, double) - Constructor for class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
- SimplexSolver - Class in fr.cnes.sirius.patrius.math.optim.linear
-
Solves a linear problem using the "Two-Phase Simplex" method.
- SimplexSolver() - Constructor for class fr.cnes.sirius.patrius.math.optim.linear.SimplexSolver
-
Builds a simplex solver with default settings.
- SimplexSolver(double, int) - Constructor for class fr.cnes.sirius.patrius.math.optim.linear.SimplexSolver
-
Builds a simplex solver with a specified accepted amount of error.
- SIMPSON_MAX_ITERATIONS_COUNT - Static variable in class fr.cnes.sirius.patrius.math.analysis.integration.SimpsonIntegrator
-
Maximal number of iterations for Simpson.
- SimpsonIntegrator - Class in fr.cnes.sirius.patrius.math.analysis.integration
-
Implements
Simpson's Rule for integration of real univariate functions.
- SimpsonIntegrator(double, double, int, int) - Constructor for class fr.cnes.sirius.patrius.math.analysis.integration.SimpsonIntegrator
-
Build a Simpson integrator with given accuracies and iterations counts.
- SimpsonIntegrator(int, int) - Constructor for class fr.cnes.sirius.patrius.math.analysis.integration.SimpsonIntegrator
-
Build a Simpson integrator with given iteration counts.
- SimpsonIntegrator() - Constructor for class fr.cnes.sirius.patrius.math.analysis.integration.SimpsonIntegrator
-
Construct an integrator with default settings.
- simpsonMean(double[]) - Static method in class fr.cnes.sirius.patrius.stela.forces.Squaring
-
Simpson's rule.
- simpsonMean(double[], double) - Static method in class fr.cnes.sirius.patrius.stela.forces.Squaring
-
Simpson's rule when the integration is not done on the entire orbit, but only on one specific part.
- simultaneous(L) - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Returns leg(s) at the same date.
- simultaneous(L) - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Such a StrictLegsSequence cannot have simultaneous legs!
- simultaneous(TimeStamped) - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Such a StrictLegsSequence cannot have simultaneous legs.
- simultaneous(TimeStamped) - Method in interface fr.cnes.sirius.patrius.utils.legs.TimeSequence
-
Returns all simultaneous elements.
- sin() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Sine operation.
- sin(double[], int, double[], int) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Compute sine of a derivative structure.
- Sin - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Sine function.
- Sin() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Sin
-
- sin() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Compute the
sine
of this complex number.
- sin(Dfp) - Static method in class fr.cnes.sirius.patrius.math.dfp.DfpMath
-
computes the sine of the argument.
- sin(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Sine function.
- sin(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Sine function.
- sin(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Sine function.
- sin(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Sine function.
- sin(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Sine function.
- sin(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Sine function.
- sin(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Sine function.
- sin() - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Sine operation.
- sin(double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Sine function.
- sin(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Sine function.
- SIN_I_LIM - Static variable in class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Sinus of half limit inclination in type 8.
- sinAndCos(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Computes sine and cosine of an angle together.
- sinAndCos(double, double[]) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Computes sine and cosine of an angle together.
- sinAndCos(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Computes sine and cosine of an angle together.
- sinAndCos(double, double[]) - Static method in class fr.cnes.sirius.patrius.math.util.JafamaFastMath
-
Computes sine and cosine of an angle together.
- sinAndCos(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Computes sine and cosine of an angle together.
- sinAndCos(double, double[]) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Computes sine and cosine of an angle together.
- Sinc - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Sinc function,
defined by
sinc(x) = 1 if x = 0,
sin(x) / x otherwise.
- Sinc() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Sinc
-
The sinc function, sin(x) / x.
- Sinc(boolean) - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Sinc
-
Instantiates the sinc function.
- SineFunction - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Sine function of the form c.sin(f(x)) with f an univariate function that returns an angle in radians.
- SineFunction(double, UnivariateDifferentiableFunction) - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.SineFunction
-
Constructor.
- SingularMatrixException - Exception in fr.cnes.sirius.patrius.math.linear
-
Exception to be thrown when a non-singular matrix is expected.
- SingularMatrixException() - Constructor for exception fr.cnes.sirius.patrius.math.linear.SingularMatrixException
-
Construct an exception.
- SingularOperatorException - Exception in fr.cnes.sirius.patrius.math.linear
-
Exception to be thrown when trying to invert a singular operator.
- SingularOperatorException() - Constructor for exception fr.cnes.sirius.patrius.math.linear.SingularOperatorException
-
Creates a new instance of this class.
- SingularValueDecomposition - Class in fr.cnes.sirius.patrius.math.linear
-
Calculates the compact Singular Value Decomposition of a matrix.
- SingularValueDecomposition(RealMatrix) - Constructor for class fr.cnes.sirius.patrius.math.linear.SingularValueDecomposition
-
Simple constructor.
- sinh() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Hyperbolic sine operation.
- sinh(double[], int, double[], int) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Compute hyperbolic sine of a derivative structure.
- Sinh - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Hyperbolic sine function.
- Sinh() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Sinh
-
- sinh() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
- sinh(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Compute the hyperbolic sine of a number.
- sinh(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Compute the hyperbolic sine of a number.
- sinh(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Compute the hyperbolic sine of a number.
- sinh(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Compute the hyperbolic sine of a number.
- sinh(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Compute the hyperbolic sine of a number.
- sinh(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Compute the hyperbolic sine of a number.
- sinh(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Compute the hyperbolic sine of a number.
- sinh() - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Hyperbolic sine operation.
- sinh(double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Compute the hyperbolic sine of a number.
- sinh(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Compute the hyperbolic sine of a number.
- sinhAndCosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double, double[]) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double, double[]) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double, double[]) - Static method in class fr.cnes.sirius.patrius.math.util.JafamaFastMath
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Computes hyperbolic sine and hyperbolic cosine together.
- sinhAndCosh(double, double[]) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Computes hyperbolic sine and hyperbolic cosine together.
- sini0 - Variable in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
sinus original inclination.
- SIXTY - Static variable in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
-
Constant 60
- size() - Method in class fr.cnes.sirius.patrius.attitudes.profiles.QuaternionDatePolynomialProfile
-
Return the size of the segments list.
- size() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.AbstractEOPHistory
-
Get the number of entries in the history.
- size() - Method in interface fr.cnes.sirius.patrius.frames.configuration.eop.EOPHistory
-
Get the number of entries in the history.
- size() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NoEOP2000History
-
size.
- size() - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.utilities.AVLTree
-
Get the number of elements of the tree.
- size() - Method in class fr.cnes.sirius.patrius.math.util.OpenIntToDoubleHashMap
-
Get the number of elements stored in the map.
- size() - Method in class fr.cnes.sirius.patrius.math.util.OpenIntToFieldHashMap
-
Get the number of elements stored in the map.
- size() - Method in class fr.cnes.sirius.patrius.time.IntervalMapSearcher
-
Return the number of elements.
- size() - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
- SIZEDESC - Static variable in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Size of the descriptor array.
- Skewness - Class in fr.cnes.sirius.patrius.math.stat.descriptive.moment
-
Computes the skewness of the available values.
- Skewness() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Skewness
-
Constructs a Skewness
- Skewness(ThirdMoment) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Skewness
-
Constructs a Skewness with an external moment
- Skewness(Skewness) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.Skewness
-
Copy constructor, creates a new Skewness identical
to the original
- SLAVE_MODE - Static variable in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
-
Indicator for slave mode.
- SLAVE_MODE - Static variable in interface fr.cnes.sirius.patrius.propagation.Propagator
-
Indicator for slave mode.
- slerp(AbsoluteDate, Attitude, Attitude, Frame, boolean) - Static method in class fr.cnes.sirius.patrius.attitudes.Attitude
-
The slerp interpolation method is efficient but is less accurate than the interpolate method.
- slerp(Rotation, Rotation, double) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Rotation
-
Returns spherical linear interpolated rotation.
- Slew - Interface in fr.cnes.sirius.patrius.attitudes
-
This interface represents a slew model set.
- SmallManeuverAnalyticalModel - Class in fr.cnes.sirius.patrius.forces.maneuvers
-
Analytical model for small maneuvers.
- SmallManeuverAnalyticalModel(SpacecraftState, Vector3D, double, String) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.SmallManeuverAnalyticalModel
-
Build a maneuver defined in spacecraft frame.
- SmallManeuverAnalyticalModel(SpacecraftState, Frame, Vector3D, double, String) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.SmallManeuverAnalyticalModel
-
Build a maneuver defined in user-specified frame.
- smooth(double[], double[], double[]) - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.LoessInterpolator
-
Compute a weighted loess fit on the data at the original abscissae.
- smooth(double[], double[]) - Method in class fr.cnes.sirius.patrius.math.analysis.interpolation.LoessInterpolator
-
Compute a loess fit on the data at the original abscissae.
- SmoothingPolynomialBicubicSplineInterpolator - Class in fr.cnes.sirius.patrius.math.analysis.interpolation
-
Generates a bicubic interpolation function.
- SmoothingPolynomialBicubicSplineInterpolator() - Constructor for class fr.cnes.sirius.patrius.math.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
-
Default constructor.
- SmoothingPolynomialBicubicSplineInterpolator(int) - Constructor for class fr.cnes.sirius.patrius.math.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
-
- SmoothingPolynomialBicubicSplineInterpolator(int, int) - Constructor for class fr.cnes.sirius.patrius.math.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
-
- SNAN - Static variable in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Indicator value for signaling NaN.
- solActType - Variable in class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaConstantSolarActivity
-
Solar activity type.
- SOLAR_SYSTEM_BARYCENTER - Static variable in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Predefined name for solar system barycenter.
- SolarActivityDataFactory - Class in fr.cnes.sirius.patrius.forces.atmospheres.solarActivity
-
- SolarActivityDataProvider - Interface in fr.cnes.sirius.patrius.forces.atmospheres.solarActivity
-
Interface for solar activity data providers, to be used for atmosphere models
- SolarActivityDataReader - Class in fr.cnes.sirius.patrius.forces.atmospheres.solarActivity
-
Represents a basic solar activity file reader.
- SolarActivityDataReader(String) - Constructor for class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Constructor.
- SolarActivityToolbox - Class in fr.cnes.sirius.patrius.forces.atmospheres.solarActivity
-
Solar activity toolbox.
- SolarRadiationPressure - Class in fr.cnes.sirius.patrius.forces.radiation
-
Solar radiation pressure force model considering spherical/circular or non-spherical (ellipsoid)
occulting bodies.
- SolarRadiationPressure(PVCoordinatesProvider, double, RadiationSensitive) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Simple constructor with default reference values.
- SolarRadiationPressure(PVCoordinatesProvider, double, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Simple constructor with default reference values.
- SolarRadiationPressure(PVCoordinatesProvider, double, CelestialBodyFrame, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Simple constructor with default reference values.
- SolarRadiationPressure(double, double, PVCoordinatesProvider, double, double, RadiationSensitive) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Complete constructor.
- SolarRadiationPressure(double, double, PVCoordinatesProvider, double, double, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Complete constructor.
- SolarRadiationPressure(double, double, PVCoordinatesProvider, double, double, CelestialBodyFrame, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Complete constructor.
- SolarRadiationPressure(Parameter, PVCoordinatesProvider, double, RadiationSensitive) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Complete constructor.
- SolarRadiationPressure(Parameter, PVCoordinatesProvider, double, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Complete constructor.
- SolarRadiationPressure(Parameter, PVCoordinatesProvider, double, double, CelestialBodyFrame, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Complete constructor.
- SolarRadiationPressure(PVCoordinatesProvider, BodyShape, RadiationSensitive) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Simple constructor with default reference values.
- SolarRadiationPressure(PVCoordinatesProvider, BodyShape, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Simple constructor with default reference values.
- SolarRadiationPressure(double, double, PVCoordinatesProvider, double, BodyShape, RadiationSensitive) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Complete constructor.
- SolarRadiationPressure(double, double, PVCoordinatesProvider, double, BodyShape, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Complete constructor.
- SolarRadiationPressure(Parameter, PVCoordinatesProvider, BodyShape, RadiationSensitive) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
- SolarRadiationPressure(Parameter, PVCoordinatesProvider, double, BodyShape, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
- SolarRadiationPressure(double, double, PVCoordinatesProvider, double, BodyShape, Assembly, double) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Creates a new instance.
- SolarRadiationPressure(SolarRadiationPressure, Assembly) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.SolarRadiationPressure
-
Creates a new instance from the data in another one but with a different assembly.
- SolarRadiationWrench - Class in fr.cnes.sirius.patrius.wrenches
-
This class represents a solar radiation wrench model.
- SolarRadiationWrench(PVCoordinatesProvider, BodyShape, RadiationWrenchSensitive) - Constructor for class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
-
Simple constructor with default reference values.
- SolarRadiationWrench(double, double, double, PVCoordinatesProvider, BodyShape, RadiationWrenchSensitive) - Constructor for class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
-
Complete constructor.
- SolarRadiationWrench(Parameter, Parameter, Parameter, PVCoordinatesProvider, BodyShape, RadiationWrenchSensitive) - Constructor for class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
-
- SolarTimeAngleDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Detects when the solar time angle of a spacecraft is equal to a predetermined value.
- SolarTimeAngleDetector(double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Constructor for a SolarTimeDetector instance.
- SolarTimeAngleDetector(double, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Constructor for a SolarTimeDetector instance with complimentary parameters.
- SolarTimeAngleDetector(double, double, double, CelestialBodyFrame) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Constructor for a SolarTimeDetector instance with complimentary parameters.
- SolarTimeAngleDetector(double, double, double, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Constructor for a SolarTimeDetector instance with complimentary parameters.
- SolarTimeAngleDetector(double, double, double, CelestialBodyFrame, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Constructor for a SolarTimeDetector instance with complimentary parameters.
- SolarTimeAngleDetector(double, double, double, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Constructor for a SolarTimeDetector instance with complimentary parameters.
- SolarTimeAngleDetector(double, double, double, CelestialBodyFrame, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Constructor for a SolarTimeDetector instance with complimentary parameters.
- SolarTimeAngleDetector(double, PVCoordinatesProvider, double, double, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Constructor for a SolarTimeDetector instance with complimentary parameters.
- SolarTimeAngleDetector(double, PVCoordinatesProvider, double, double, CelestialBodyFrame, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SolarTimeAngleDetector
-
Constructor for a SolarTimeDetector instance with complimentary parameters.
- solidEarthTidesCorrections(AbsoluteDate, Vector3D, Vector3D, Vector3D) - Static method in class fr.cnes.sirius.patrius.forces.gravity.tides.ReferencePointsDisplacement
-
Computes the displacement of reference points due to the effect of the solid Earth tides.
- SolidShape - Interface in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
Interface for all solids.
- SolidTidesAcc - Class in fr.cnes.sirius.patrius.stela.forces.gravity
-
Class representing the tidal contribution.
- SolidTidesAcc(CelestialPoint, CelestialPoint) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
-
Default constructor: both sun and moon contributions have to be computed.
- SolidTidesAcc(boolean, boolean, CelestialPoint, CelestialPoint) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
-
Advanced constructor: the user can choose if the sun or the moon contribution has to be deactivated.
- solve(int, F, double, double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Solve for a zero in the given interval, start at startValue.
- solve(int, F, double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Solve for a zero root in the given interval.
- solve(int, F, double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseAbstractUnivariateSolver
-
Solve for a zero in the vicinity of startValue.
- solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseSecantSolver
-
Solve for a zero in the given interval.
- solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseSecantSolver
-
Solve for a zero in the given interval, start at startValue.
- solve(int, UnivariateFunction, double, double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BaseSecantSolver
-
Solve for a zero in the given interval, start at startValue.
- solve(int, Func, double, double) - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BaseUnivariateSolver
-
Solve for a zero root in the given interval.
- solve(int, Func, double, double, double) - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BaseUnivariateSolver
-
Solve for a zero in the given interval, start at startValue.
- solve(int, Func, double) - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BaseUnivariateSolver
-
Solve for a zero in the vicinity of startValue.
- solve(int, Func, double, double, AllowedSolution) - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BracketedUnivariateSolver
-
Solve for a zero in the given interval.
- solve(int, Func, double, double, double, AllowedSolution) - Method in interface fr.cnes.sirius.patrius.math.analysis.solver.BracketedUnivariateSolver
-
Solve for a zero in the given interval, start at startValue.
- solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BracketingNthOrderBrentSolver
-
Solve for a zero in the given interval.
- solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.BracketingNthOrderBrentSolver
-
Solve for a zero in the given interval, start at startValue.
- solve(int, UnivariateDifferentiableFunction, double, double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.NewtonRaphsonSolver
-
Find a zero near the midpoint of min and max.
- solve(UnivariateFunction, double, double) - Static method in class fr.cnes.sirius.patrius.math.analysis.solver.UnivariateSolverUtils
-
Convenience method to find a zero of a univariate real function.
- solve(UnivariateFunction, double, double, double) - Static method in class fr.cnes.sirius.patrius.math.analysis.solver.UnivariateSolverUtils
-
Convenience method to find a zero of a univariate real function.
- solve(int, UnivariateDfpFunction, Dfp, Dfp, AllowedSolution) - Method in class fr.cnes.sirius.patrius.math.dfp.BracketingNthOrderBrentSolverDFP
-
Solve for a zero in the given interval.
- solve(int, UnivariateDfpFunction, Dfp, Dfp, Dfp, AllowedSolution) - Method in class fr.cnes.sirius.patrius.math.dfp.BracketingNthOrderBrentSolverDFP
-
Solve for a zero in the given interval, start at startValue.
- solve(RealVector) - Method in interface fr.cnes.sirius.patrius.math.linear.DecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(RealMatrix) - Method in interface fr.cnes.sirius.patrius.math.linear.DecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(FieldVector<T>) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldDecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(FieldMatrix<T>) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldDecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(RealLinearOperator, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.IterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.IterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector, boolean, double) - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns an estimate of the solution to the linear system (A - shift
· I) · x = b.
- solve(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector, boolean, double) - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns the solution to the system (A - shift · I) · x = b.
- solve(RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealVector) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.CholeskyFactorization
-
Solver for system AX = b.
- solve(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.CholeskyFactorization
-
Solver for system AX = b.
- solve() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Returns two vectors v and w solutions of the KKT system.
- solve() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AugmentedKKTSolver
-
Returns the two vectors v and w.
- solve() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.BasicKKTSolver
-
Returns the two vectors v and w.
- solve() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.UpperDiagonalHKKTSolver
-
Returns the two vectors v and w.
- solveAllComplex(double[], double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.LaguerreSolver
-
Find all complex roots for the polynomial with the given
coefficients, starting from the given initial value.
- solveAugmentedKKT() - Method in class fr.cnes.sirius.patrius.math.optim.joptimizer.solvers.AbstractKKTSolver
-
Solve the augmented KTT system
- solveBiquadratic(double, double, double) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Solves the equation c4x4 + c2x2 + c0 = 0.
- solveComplex(double[], double) - Method in class fr.cnes.sirius.patrius.math.analysis.solver.LaguerreSolver
-
Find a complex root for the polynomial with the given coefficients,
starting from the given initial value.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ConjugateGradient
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.IterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector, boolean, double) - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns an estimate of the solution to the linear system (A - shift
· I) · x = b.
- solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInverseCumulativeProbability(double, int, int) - Method in class fr.cnes.sirius.patrius.math.distribution.AbstractIntegerDistribution
-
- solveKeplerEquationEccentricAnomaly(double, double) - Static method in class fr.cnes.sirius.patrius.orbits.orbitalparameters.KeplerianParameters
-
Solve the Kepler equation to get the eccentric anomaly : E - e*sin(E)= M
- solveLowerTriangularSystem(RealMatrix, RealVector) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Solve a system of composed of a Lower Triangular Matrix
RealMatrix.
- solvePhase1(SimplexTableau) - Method in class fr.cnes.sirius.patrius.math.optim.linear.SimplexSolver
-
Solves Phase 1 of the Simplex method.
- solvePolyDeg2(Complex, Complex, Complex) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Solves the complex equation c2x2 + c1x + c0 = 0.
- solvePolyDeg3(double, double, double, double) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Solves the equation c3x3 + c2x2 + c1x + c0 = 0.
- solvePolyDeg4(double, double, double, double, double) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Solves the equation c4x4 + c3x3 + c2x2 +
c1x + c0 = 0.
- solveQuadraticEquation(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Calculation of a quadratic equation (ax^2 + bx + c) and return the positive root
- solveQuadraticEquationMaxRoot(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Calculation of a quadratic equation (ax^2 + bx + c) and return the positive root
- solveQuadraticEquationMinRoot(double, double, double) - Static method in class fr.cnes.sirius.patrius.math.util.MathUtils
-
Calculation of a quadratic equation (ax^2 + bx + c) and return the positive root
- SOLVER_DEFAULT_ABSOLUTE_ACCURACY - Static variable in class fr.cnes.sirius.patrius.math.distribution.AbstractRealDistribution
-
Default accuracy.
- solveUpperTriangularSystem(RealMatrix, RealVector) - Static method in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Solver a system composed of an Upper Triangular Matrix
RealMatrix.
- sortInPlace(double[], double[]...) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Sort an array in ascending order in place and perform the same reordering
of entries on other arrays.
- sortInPlace(double[], MathArrays.OrderDirection, double[]...) - Static method in class fr.cnes.sirius.patrius.math.util.MathArrays
-
Sort an array in place and perform the same reordering of entries on
other arrays.
- sortVerticies(Vector2D[][], boolean) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.PolygonsSet
-
Method to sort vertices according to a specific sense : (trigonometric or clockwise)
- SP3File - Class in fr.cnes.sirius.patrius.files.sp3
-
Represents a parsed SP3 orbit file.
- SP3File() - Constructor for class fr.cnes.sirius.patrius.files.sp3.SP3File
-
Create a new SP3 file object.
- SP3File.SP3FileType - Enum in fr.cnes.sirius.patrius.files.sp3
-
File type indicator.
- SP3File.SP3OrbitType - Enum in fr.cnes.sirius.patrius.files.sp3
-
Orbit type indicator.
- SP3Parser - Class in fr.cnes.sirius.patrius.files.sp3
-
A parser for the SP3 orbit file format.
- SP3Parser() - Constructor for class fr.cnes.sirius.patrius.files.sp3.SP3Parser
-
- SP_IERS2003 - Static variable in class fr.cnes.sirius.patrius.frames.configuration.sp.SPrimeModelFactory
-
IERS 2003 convention.
- SP_IERS2010 - Static variable in class fr.cnes.sirius.patrius.frames.configuration.sp.SPrimeModelFactory
-
IERS 2010 convention.
- SPACE - Static variable in class fr.cnes.sirius.patrius.bodies.AbstractCelestialBody
-
Space.
- Space - Interface in fr.cnes.sirius.patrius.math.geometry
-
This interface represents a generic space, with affine and vectorial counterparts.
- SPACE - Static variable in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Space character (' ').
- spacecraftsMaskingDistance(AbsoluteDate, AbsoluteDate, AbstractSignalPropagationDetector.PropagationDelayType, VisibilityFromStationDetector.LinkType) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
-
Computes the minimal euclidian distance to the spacecraft's shapes (GEOMERTY properties).
- SpacecraftState - Class in fr.cnes.sirius.patrius.propagation
-
This class is the representation of a complete state holding orbit, attitude for forces and
events computation and
additional states informations at a given date.
- SpacecraftState(Orbit) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit only.
- SpacecraftState(Orbit, Attitude) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit and a single attitude.
- SpacecraftState(Orbit, MassProvider) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Create a new instance from orbit and mass provider.
- SpacecraftState(Orbit, Attitude, MassProvider) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitude and mass provider.
- SpacecraftState(Orbit, Attitude, Attitude) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitude for forces and events computation.
- SpacecraftState(Orbit, Attitude, Attitude, Map<String, double[]>) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitude for forces and events computation and
additional states map.
- SpacecraftState(Orbit, Attitude, Attitude, MassProvider) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitude for forces and events computation and mass
provider.
- SpacecraftState(Orbit, Attitude, Attitude, MassProvider, Map<String, double[]>) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitude for forces and events computation, mass
provider and additional
states map.
- SpacecraftState(AttitudeProvider, Orbit) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit and a single attitude provider.
- SpacecraftState(AttitudeProvider, Orbit, MassProvider) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitude provider and mass provider.
- SpacecraftState(AttitudeProvider, AttitudeProvider, Orbit) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitude for forces and events computation.
- SpacecraftState(AttitudeProvider, AttitudeProvider, Orbit, Map<String, double[]>) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitude for forces and events computation and
additional states map.
- SpacecraftState(AttitudeProvider, AttitudeProvider, Orbit, MassProvider) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitude for forces and events computation and mass
provider.
- SpacecraftState(AttitudeProvider, AttitudeProvider, Orbit, MassProvider, Map<String, double[]>) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft state from orbit, attitudeProviders for forces and events computation,
mass provider and additional states map.
- SpacecraftState(double[], OrbitType, PositionAngle, AbsoluteDate, double, Frame, Map<String, AdditionalStateInfo>, AttitudeProvider, AttitudeProvider) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft from an array (a state vector) and an additional states informations map.
- SpacecraftState(double[], OrbitType, PositionAngle, AbsoluteDate, double, Frame, Map<String, AdditionalStateInfo>, Attitude, Attitude) - Constructor for class fr.cnes.sirius.patrius.propagation.SpacecraftState
-
Build a spacecraft from an array (a state vector) and an additional states informations map.
- SpacecraftStateProvider - Interface in fr.cnes.sirius.patrius.propagation
-
Interface for spacecraft state providers.
- SpearmansCorrelation - Class in fr.cnes.sirius.patrius.math.stat.correlation
-
Spearman's rank correlation.
- SpearmansCorrelation() - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation without data.
- SpearmansCorrelation(RankingAlgorithm) - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation with the given ranking algorithm.
- SpearmansCorrelation(RealMatrix) - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation from the given data matrix.
- SpearmansCorrelation(RealMatrix, RankingAlgorithm) - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation with the given input data matrix
and ranking algorithm.
- SPECULAR_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
-
Parameter name for reflection coefficient.
- SPECULAR_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
-
Parameter name for reflection coefficient.
- SPEED_OF_LIGHT - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Speed of light: 299792458.0 m/s.
- Sphere - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
This is a describing class for a 3D spherical shape, with some algorithm to compute intersections and distances to
some other objects.
- Sphere(Vector3D, double) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Build a sphere from its radius and the position of its center
- Sphere(double) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Sphere
-
Build a sphere centered in [0, 0, 0] from its projected surface.
- SphericalCap - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
Implements a representation of a spherical cap solid.
- SphericalCap(Sphere, Plane) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCap
-
Constructor of a
SphericalCap using a
Sphere and a
Plane.
- SphericalCoordinates - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
This class provides spherical coordinates (elevation, azimuth, norm) from a Vector3D.
- SphericalCoordinates(double, double, double) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCoordinates
-
Build a new instance.
- SphericalCoordinates(double, double, double, boolean) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCoordinates
-
Build a new instance.
- SphericalCoordinates(Vector3D) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SphericalCoordinates
-
Builds a new instance that represents a 3D vector.
- SphericalGridAttractionLoader - Class in fr.cnes.sirius.patrius.forces.gravity.grid
-
Grid attraction model loader.
- SphericalGridAttractionLoader(String) - Constructor for class fr.cnes.sirius.patrius.forces.gravity.grid.SphericalGridAttractionLoader
-
Constructor.
- Spheroid - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
This is the Spheroid (also called Revolved Ellipsoid) class.
- Spheroid(Vector3D, Vector3D, double, double) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Spheroid
-
This constructor builds a spheroid from its centers position, its revolution axis and its equatorial and
polar radius.
- SPICE_J2000_EPOCH - Static variable in class fr.cnes.sirius.patrius.bodies.bsp.BSPEphemerisLoader
-
The basic spatial reference system for SPICE is the J2000 system.
- SpiceBody - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
This class allows the translation of SPICE body identifiers to the body names and vice-versa.
- SpiceChangeFrame - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
This class is made to support changes among a standard set of inertial coordinate reference frames.
- SpiceCommon - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
Class containing constants and auxiliary methods for the rest of the SPICE related classes.
- SpiceFrame - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
This class contains the methods necessaries for manipulating different reference frames.
- SpiceKernelInfo - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
Class created to contain the information relative to SPICE kernel loaded for
SpiceKernelManager.
- SpiceKernelInfo(String, String, int, int) - Constructor for class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceKernelInfo
-
Constructor.
- SpiceKernelManager - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
This class goal is to manage the loading and unloading of SPICE kernels from other PATRIUS methods.
- spinDerivativesComputation - Variable in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAngularVelocitiesAttitudeProfile
-
Boolean for spin derivative computation.
- SpinStabilized - Class in fr.cnes.sirius.patrius.attitudes
-
This class handles a spin stabilized attitude provider.
- SpinStabilized(AttitudeLaw, AbsoluteDate, Vector3D, double) - Constructor for class fr.cnes.sirius.patrius.attitudes.SpinStabilized
-
Creates a new instance.
- spinVectorFunction - Variable in class fr.cnes.sirius.patrius.attitudes.profiles.AbstractAngularVelocitiesAttitudeProfile
-
- SPK - Static variable in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceCommon
-
String literal for SPK file type.
- SpkBody - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
Class that allows to instantiate a SpkBody to be used in
SpkFile.
- SpkBody(int, int, int, int, double, double, double[], String, int, boolean, int) - Constructor for class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Constructor.
- SpkBody(int) - Constructor for class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkBody
-
Simple constructor for finding SpkBody in a list.
- SpkFile - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
Load and unload files for use by the readers.
- spkObjects(String, Set<Integer>) - Static method in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkReader
-
Find the set of ID codes of all objects in a specified SPK file.
- SpkReader - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
This class contains the methods linked to the reading of SPK files.
- SpkRecord - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
Class for the reading and evaluation of SPK records.
- SpkSegment - Class in fr.cnes.sirius.patrius.bodies.bsp.spice
-
Class allowing to instantiate Spk Segments for the list in
SpkBody.
- SpkSegment(int, double[], String) - Constructor for class fr.cnes.sirius.patrius.bodies.bsp.spice.SpkSegment
-
Constructor.
- spline(double[], double[], int, double, double, double[]) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.NRLMSISE00
-
spline.
- SplineInterpolator - Class in fr.cnes.sirius.patrius.math.analysis.interpolation
-
Computes a natural (also known as "free", "unclamped") cubic spline interpolation for the data set.
- SplineInterpolator() - Constructor for class fr.cnes.sirius.patrius.math.analysis.interpolation.SplineInterpolator
-
- splint(double[], double[], double[], int, double) - Method in class fr.cnes.sirius.patrius.forces.atmospheres.MSIS2000.NRLMSISE00
-
splint calculate cubic spline interpolation value adapted from numerical recipes by press et al.
- split(Hyperplane<Euclidean1D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.SubOrientedPoint
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<Euclidean3D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SubPlane
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<Euclidean2D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.SubLine
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.AbstractSubHyperplane
-
Split the instance in two parts by an hyperplane.
- split(SubHyperplane<S>) - Method in class fr.cnes.sirius.patrius.math.geometry.partitioning.BSPTree
-
Split a BSP tree by an external sub-hyperplane.
- split(Hyperplane<S>) - Method in interface fr.cnes.sirius.patrius.math.geometry.partitioning.SubHyperplane
-
Split the instance in two parts by an hyperplane.
- SplitSubHyperplane(SubHyperplane<U>, SubHyperplane<U>) - Constructor for class fr.cnes.sirius.patrius.math.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Build a SplitSubHyperplane from its parts.
- SPMG - Static variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Sine of the latitude of the magnetic pole (79N, 71W).
- SPrimeModel - Interface in fr.cnes.sirius.patrius.frames.configuration.sp
-
This interface provides the s' correction (used for the following transformation : TIRF -> ITRF).
- SPrimeModelFactory - Class in fr.cnes.sirius.patrius.frames.configuration.sp
-
Factory for predefined models.
- sqrt() - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
Square root.
- Sqrt - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Square-root function.
- Sqrt() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Sqrt
-
- sqrt() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
- sqrt() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Compute the square root.
- sqrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastestMathLibWrapper
-
Compute the square root of a number.
- sqrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.FastMathWrapper
-
Compute the square root of a number.
- sqrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaFastMathWrapper
-
Compute the square root of a number.
- sqrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.JafamaStrictFastMathWrapper
-
Compute the square root of a number.
- sqrt(double) - Method in interface fr.cnes.sirius.patrius.math.framework.MathLibrary
-
Compute the square root of a number.
- sqrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.MathWrapper
-
Compute the square root of a number.
- sqrt(double) - Method in class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
Compute the square root of a number.
- sqrt() - Method in class fr.cnes.sirius.patrius.math.linear.JacobiPreconditioner
-
Returns the square root of this diagonal operator.
- sqrt() - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
Square root.
- sqrt(double) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Compute the square root of a number.
- sqrt(double) - Static method in class fr.cnes.sirius.patrius.math.util.MathLib
-
Compute the square root of a number.
- sqrt1z() - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Compute the
square root of
1 - this2 for this complex
number.
- Squaring - Class in fr.cnes.sirius.patrius.stela.forces
-
Class containing methods used to compute Simpson's quadrature.
- Squaring() - Constructor for class fr.cnes.sirius.patrius.stela.forces.Squaring
-
- SRPPotential - Class in fr.cnes.sirius.patrius.stela.forces.radiation
-
This class represents the PRS Lagrange contribution in the STELA propagator context.
- SRPPotential(PVCoordinatesProvider, double, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.radiation.SRPPotential
-
create a SRP Potential model using the sun and spacecraft characteristics.
- SRPSquaring - Class in fr.cnes.sirius.patrius.stela.forces.radiation
-
Class representing the srp gauss force model for STELA
- SRPSquaring(RadiationSensitive, PVCoordinatesProvider, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Create an instance with an assembly and a number of points.
- SRPSquaring(RadiationSensitive, int, PVCoordinatesProvider, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Create an instance with an assembly and a number of points.
- SRPSquaring(RadiationSensitive, int, PVCoordinatesProvider, double, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Create an instance with an assembly and a number of points.
- SRPSquaring(RadiationSensitive, int, PVCoordinatesProvider, double, double, double, int) - Constructor for class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
-
Create an instance with an assembly and a number of points.
- SSBEphemeris() - Constructor for class fr.cnes.sirius.patrius.bodies.BSPCelestialBodyLoader.SSBEphemeris
-
- StableRandomGenerator - Class in fr.cnes.sirius.patrius.math.random
-
This class provides a stable normalized random generator.
- StableRandomGenerator(RandomGenerator, double, double) - Constructor for class fr.cnes.sirius.patrius.math.random.StableRandomGenerator
-
Create a new generator.
- stage(BaseAbstractUnivariateIntegrator, int) - Method in class fr.cnes.sirius.patrius.math.analysis.integration.TrapezoidIntegrator
-
Compute the n-th stage integral of trapezoid rule.
- STANDARD - Static variable in class fr.cnes.sirius.patrius.signalpropagation.MeteorologicalConditions
-
- StandardDeviation - Class in fr.cnes.sirius.patrius.math.stat.descriptive.moment
-
Computes the sample standard deviation.
- StandardDeviation() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Constructs a StandardDeviation.
- StandardDeviation(SecondMoment) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Constructs a StandardDeviation from an external second moment.
- StandardDeviation(StandardDeviation) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Copy constructor, creates a new StandardDeviation identical
to the original
- StandardDeviation(boolean) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Contructs a StandardDeviation with the specified value for the isBiasCorrected property.
- StandardDeviation(boolean, SecondMoment) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.moment.StandardDeviation
-
Contructs a StandardDeviation with the specified value for the isBiasCorrected property and the
supplied external moment.
- standardDeviation(double[]) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the standard deviation of the entries in the input array, or Double.NaN if the array is
empty.
- standardDeviation(double[], int, int) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the standard deviation of the entries in the specified portion of
the input array, or Double.NaN if the designated subarray
is empty.
- standardDeviation(double[], double, int, int) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the standard deviation of the entries in the specified portion of
the input array, using the precomputed mean value.
- standardDeviation(double[], double) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the standard deviation of the entries in the input array, using the
precomputed mean value.
- StandardFieldDescriptors - Class in fr.cnes.sirius.patrius.math.parameter
-
Standard field descriptors.
- StarConvexBodyShape - Interface in fr.cnes.sirius.patrius.bodies
-
Extended interface for star-convex bodies shapes : extends the
BodyShape interface by adding a method to get
a
BodyPoint of the shape from given latitude,longitude and altitude.
- StarConvexFacetBodyShape - Class in fr.cnes.sirius.patrius.bodies.mesh
-
Star-convex facet body shape defined by a list of facets.
- StarConvexFacetBodyShape(String, CelestialBodyFrame, MeshProvider) - Constructor for class fr.cnes.sirius.patrius.bodies.mesh.StarConvexFacetBodyShape
-
Constructor for a star convex FacetBodyShape.
- start(int, int, int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DefaultFieldMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DefaultFieldMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DefaultRealMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in class fr.cnes.sirius.patrius.math.linear.DefaultRealMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealVectorChangingVisitor
-
Start visiting a vector.
- start(int, int, int) - Method in interface fr.cnes.sirius.patrius.math.linear.RealVectorPreservingVisitor
-
Start visiting a vector.
- start(double, double[], double) - Method in class fr.cnes.sirius.patrius.math.ode.MultistepIntegrator
-
Start the integration.
- START_END_TRANSITIONS - Static variable in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeEphemerisGenerator
-
The start and the end point of the laws are computed.
- START_TRANSITIONS - Static variable in class fr.cnes.sirius.patrius.attitudes.AbstractAttitudeEphemerisGenerator
-
The start date of the laws are computed.
- STATE_LENGTH - Static variable in class fr.cnes.sirius.patrius.bodies.bsp.spice.SpiceChangeFrame
-
Length of an state array.
- STATE_SIZE - Static variable in class fr.cnes.sirius.patrius.stela.propagation.StelaDifferentialEquations
-
Size of the state vector.
- stateVariation - Variable in class fr.cnes.sirius.patrius.math.ode.sampling.NordsieckStepInterpolator
-
State variation.
- StationToSatMutualVisibilityDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Mutual station to spacecraft visibility detector : the g function is positive only if the station's sensor sees the
spacecraft's sensor AND the spacecraft's sensor sees the station's sensor.
- StationToSatMutualVisibilityDetector(SensorModel, GeometricStationAntenna, AngularCorrection, boolean, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Constructor for the mutual station to spacecraft visibility detector
The default implementation behavior is to
continue propagation when
entering the eclipse and to
stop
propagation when exiting the eclipse.
- StationToSatMutualVisibilityDetector(SensorModel, GeometricStationAntenna, AngularCorrection, boolean, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Constructor for the mutual station to spacecraft visibility detector
- StationToSatMutualVisibilityDetector(SensorModel, GeometricStationAntenna, AngularCorrection, boolean, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Constructor for the mutual station to spacecraft visibility detector
- StationToSatMutualVisibilityDetector(SensorModel, GeometricStationAntenna, AngularCorrection, boolean, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean, VisibilityFromStationDetector.LinkType) - Constructor for class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Constructor for the mutual station to spacecraft visibility detector
- StationToSatMutualVisibilityDetector(SensorModel, TopocentricFrame, double[][], AngularCorrection, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Constructor for the mutual station to spacecraft visibility detector
The default implementation behavior is to
continue propagation when
entering the eclipse and to
stop
propagation when exiting the eclipse.
- StationToSatMutualVisibilityDetector(SensorModel, TopocentricFrame, double[][], AngularCorrection, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Constructor for the mutual station to spacecraft visibility detector
- StationToSatMutualVisibilityDetector(SensorModel, TopocentricFrame, double[][], AngularCorrection, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Constructor for the mutual station to spacecraft visibility detector
- StationToSatMutualVisibilityDetector(SensorModel, TopocentricFrame, double[][], AngularCorrection, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean, VisibilityFromStationDetector.LinkType) - Constructor for class fr.cnes.sirius.patrius.events.detectors.StationToSatMutualVisibilityDetector
-
Constructor for the mutual station to spacecraft visibility detector
- StatisticalMultivariateSummary - Interface in fr.cnes.sirius.patrius.math.stat.descriptive
-
Reporting interface for basic multivariate statistics.
- StatisticalSummary - Interface in fr.cnes.sirius.patrius.math.stat.descriptive
-
Reporting interface for basic univariate statistics.
- StatisticalSummaryValues - Class in fr.cnes.sirius.patrius.math.stat.descriptive
-
Value object representing the results of a univariate statistical summary.
- StatisticalSummaryValues(double, double, long, double, double, double) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.StatisticalSummaryValues
-
Constructor
- StatUtils - Class in fr.cnes.sirius.patrius.math.stat
-
StatUtils provides static methods for computing statistics based on data
stored in double[] arrays.
- Stela3StepsSolarActivity - Class in fr.cnes.sirius.patrius.stela.forces.solaractivity.variable
-
- Stela3StepsSolarActivity(AbsoluteDate, AbsoluteDate, double, double, List<Integer>, SolarActivityDataProvider) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.Stela3StepsSolarActivity
-
Constructor.
- Stela3StepsSolarActivity(SolarActivityDataProvider) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.Stela3StepsSolarActivity
-
Basis constructor.
- STELA_CONSTANT_DRAG_COEFFICIENT - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Constant drag coefficient value.
- STELA_COOK_ACCOMODATION - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Cook accomodation constant.
- STELA_COOK_GAZ_CONSTANT - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Cook perfect gaz constant.
- STELA_COOK_MOLAR_MASS_OXYGEN - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Cook molar mass of oxygen atom.
- STELA_COOK_WALL_TEMPERATURE - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Cook wall temperature (K).
- STELA_DEFAULT_LOS_CX - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Default drag coefficient used in MEAN_CONSTANT F107 computation.
- STELA_LOS_AP - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
AP constant for stela los
- STELA_LOS_EARTH_RADIUS - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
LOS Earth Radius (m).
- STELA_LOS_F107 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
F10.7 constant for stela los
- STELA_LOS_K0 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
k0 coefficient used in MEAN_CONSTANT F107 computation.
- STELA_LOS_K1 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
k1 coefficient used in MEAN_CONSTANT F107 computation.
- STELA_LOS_K2 - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
k2 coefficient used in MEAN_CONSTANT F107 computation.
- STELA_SPACE_OBJECT_MASS - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Space object mass (kg).
- STELA_SPACE_OBJECT_MEAN_AREA - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Space object mean area (m2).
- STELA_SPACE_OBJECT_NAME - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Space object name.
- STELA_SPACE_OBJECT_REF_AREA - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Space object reflectivity area (m2).
- STELA_SPACE_OBJECT_REFLECT_COEF - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Space object reflection coefficient.
- STELA_Z_LIMIT_ATMOS - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Altitude of the upper atmospheric boundary (m).
- StelaAbstractPropagator - Class in fr.cnes.sirius.patrius.stela.propagation
-
Common handling of
Propagator methods for analytical propagators.
- StelaAbstractPropagator(AttitudeProvider, StelaBasicInterpolator) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Build a new instance.
- StelaAbstractPropagator(AttitudeProvider, AttitudeProvider, StelaBasicInterpolator) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
-
Build a new instance.
- StelaAdditionalEquations - Interface in fr.cnes.sirius.patrius.stela.propagation
-
Interface representing the Stela GTO propagator additional equations.
- StelaAeroModel - Class in fr.cnes.sirius.patrius.stela.forces.drag
-
This class represents a STELA aero model, based on a spherical spacecraft.
- StelaAeroModel(double, AbstractStelaDragCoef, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaAeroModel
-
Constructor to be used when partial derivatives should not be computed.
- StelaAeroModel(double, AbstractStelaDragCoef, double, Atmosphere, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaAeroModel
-
Constructor to be used when partial derivatives are computed using the full finite differences method.
- StelaAeroModel(double, AbstractStelaDragCoef, double, Atmosphere, double, GeodPosition) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaAeroModel
-
Constructor to be used when partial derivatives are computed using the altitude finite differences method.
- StelaAtmosphericDrag - Class in fr.cnes.sirius.patrius.stela.forces.drag
-
Class representing the atmospheric drag for the Stela GTO extrapolator.
- StelaAtmosphericDrag(DragSensitive, Atmosphere, int, double, double, int) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaAtmosphericDrag
-
Constructor.
- StelaAtmosphericDrag(DragSensitive, Atmosphere, int, double, double, int, int) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaAtmosphericDrag
-
Constructor.
- StelaAttitudeAdditionalEquations - Class in fr.cnes.sirius.patrius.stela.propagation
-
This abstract class allows users to add their own attitude differential equations to a Stela GTO propagator.
- StelaAttitudeAdditionalEquations(AttitudeEquation.AttitudeType) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaAttitudeAdditionalEquations
-
Create a new attitude equation.
- StelaBasicInterpolator - Class in fr.cnes.sirius.patrius.stela.propagation
-
Basic Linear Step Interpolator for StelaAbstractPropagator.
- StelaBasicInterpolator() - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
-
Build a new instance from a basic propagator.
- StelaConstantDragCoef - Class in fr.cnes.sirius.patrius.stela.forces.drag
-
Class defining constant drag coefficients.
- StelaConstantDragCoef() - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaConstantDragCoef
-
Constructor initializing drag coefficient's value to a value specified in a file.
- StelaConstantDragCoef(double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaConstantDragCoef
-
Simple constructor for a constant Cd.
- StelaConstantSolarActivity - Class in fr.cnes.sirius.patrius.stela.forces.solaractivity.constant
-
Constant model of solar activity.
- StelaConstantSolarActivity(double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaConstantSolarActivity
-
Basis constructor
- StelaCookDispersedDragCoef - Class in fr.cnes.sirius.patrius.stela.forces.drag
-
Class for drag coefficients using Cook formula with a multiplicative coefficient applied to the computed drag
coefficient.
- StelaCookDispersedDragCoef() - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDispersedDragCoef
-
Constructor of a Cook dispersed drag coefficient with identity coefficient.
- StelaCookDispersedDragCoef(double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDispersedDragCoef
-
Constructor of a Cook drag coefficient with a multiplicative coefficient.
- StelaCookDispersedDragCoef(double, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDispersedDragCoef
-
Constructor of a Cook drag coefficient with a multiplicative coefficient and with advanced parameters value for
wall temperature and accommodation.
- StelaCookDragCoef - Class in fr.cnes.sirius.patrius.stela.forces.drag
-
Class for drag coefficients using Cook formula.
- StelaCookDragCoef(double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDragCoef
-
Constructor.
- StelaCookDragCoef(StelaDragCoefType, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaCookDragCoef
-
Protected constructor which allow a child different dragCoefType.
- StelaDifferentialEquations - Class in fr.cnes.sirius.patrius.stela.propagation
-
Class representing the differential system of a STELA GTO propagation.
- StelaDifferentialEquations(StelaGTOPropagator) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaDifferentialEquations
-
Build a new instance of the Stela differential equations.
- StelaDragCoefInput - Class in fr.cnes.sirius.patrius.stela.forces.drag
-
Class for drag coefficients inputs.
- StelaDragCoefInput(Vector3D, double, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaDragCoefInput
-
Full constructor.
- StelaDragCoefInput() - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaDragCoefInput
-
Constructor for constant drag coef.
- StelaDragCoefInput(Vector3D) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaDragCoefInput
-
Constructor for variable drag coef.
- StelaDragCoefInput(double, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaDragCoefInput
-
Constructor for Cook drag coefficient.
- stelaDragCoefType - Variable in class fr.cnes.sirius.patrius.stela.forces.drag.AbstractStelaDragCoef
-
Drag coefficient type
- StelaDragCoefType - Enum in fr.cnes.sirius.patrius.stela.forces.drag
-
Drag coefficient types.
- StelaEquinoctialOrbit - Class in fr.cnes.sirius.patrius.stela.orbits
-
This class handles Stela equinoctial orbital parameters, which can support both circular and
equatorial orbits.
- StelaEquinoctialOrbit(IOrbitalParameters, Frame, AbsoluteDate) - Constructor for class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Creates a new instance.
- StelaEquinoctialOrbit(double, double, double, double, double, double, Frame, AbsoluteDate, double) - Constructor for class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Creates a new instance.
- StelaEquinoctialOrbit(double, double, double, double, double, double, Frame, AbsoluteDate, double, boolean) - Constructor for class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Creates a new instance.
- StelaEquinoctialOrbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Constructor from cartesian parameters.
- StelaEquinoctialOrbit(Orbit) - Constructor for class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Constructor from any kind of orbital parameters with correction when inclination is close to
180°
- StelaEquinoctialOrbit(Orbit, boolean) - Constructor for class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
-
Constructor from any kind of orbital parameters.
- StelaEquinoctialParameters - Class in fr.cnes.sirius.patrius.orbits.orbitalparameters
-
This class handles the equinoctial orbital parameters used in Stela;
it has been created because the equinoctial parameters associated to Stela
differ from the
EquinoctialParameters parameters.
- StelaEquinoctialParameters(double, double, double, double, double, double, double, boolean) - Constructor for class fr.cnes.sirius.patrius.orbits.orbitalparameters.StelaEquinoctialParameters
-
Creates a new instance.
- StelaForceModel - Interface in fr.cnes.sirius.patrius.stela.forces
-
- StelaGTOPropagator - Class in fr.cnes.sirius.patrius.stela.propagation
-
STELA propagator for Geostationnary Transfert Orbits (GTO).
- StelaGTOPropagator(FirstOrderIntegrator) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Build a StelaGTOPropagator.
- StelaGTOPropagator(FirstOrderIntegrator, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Build a StelaGTOPropagator.
- StelaGTOPropagator(FirstOrderIntegrator, AttitudeProvider, StelaBasicInterpolator, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Build a StelaGTOPropagator.
- StelaGTOPropagator(FirstOrderIntegrator, AttitudeProvider, AttitudeProvider, StelaBasicInterpolator, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Build a StelaGTOPropagator.
- StelaLagrangeEquations - Class in fr.cnes.sirius.patrius.stela.forces
-
Class for the computation of Lagrange Equations and its derivatives
Computation of Lagrange Equations and its derivatives
- StelaLagrangeEquations() - Constructor for class fr.cnes.sirius.patrius.stela.forces.StelaLagrangeEquations
-
simple constructor
- StelaLOSConstantSolarActivity - Class in fr.cnes.sirius.patrius.stela.forces.solaractivity.constant
-
Mean constant model of solar activity.
- StelaLOSConstantSolarActivity() - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.constant.StelaLOSConstantSolarActivity
-
Constructor of a MEAN_CONSTANT solar activity model.
- StelaPartialDerivativesEquations - Class in fr.cnes.sirius.patrius.stela.propagation
-
This class represents a set of
additional equations computing the partial
derivatives of the state (orbit) with respect to initial state.
- StelaPartialDerivativesEquations(List<AbstractStelaGaussContribution>, List<AbstractStelaLagrangeContribution>, int, StelaGTOPropagator) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.StelaPartialDerivativesEquations
-
Simple constructor.
- StelaPastCyclesData - Class in fr.cnes.sirius.patrius.stela.forces.solaractivity.variable
-
Data necessary for past cycles solar activity.
- StelaPastCyclesData(int, List<Integer>, boolean) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesData
-
Past cycles solar activity constructor.
- StelaPastCycleSolarActivityProperties - Class in fr.cnes.sirius.patrius.stela.forces.solaractivity.variable
-
Class to store the past cycles solar activity files
- StelaPastCyclesSolarActivity - Class in fr.cnes.sirius.patrius.stela.forces.solaractivity.variable
-
Class for variable solar activity using past cycles.
- StelaPastCyclesSolarActivity(int, List<Integer>) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivity
-
Constructor.
- StelaPastCyclesSolarActivity(StelaPastCyclesData) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivity
-
Constructor.
- StelaPastCyclesSolarActivityReader - Class in fr.cnes.sirius.patrius.stela.forces.solaractivity.variable
-
Class to read solar activity past cycles files
- StelaPastCyclesSolarActivityReader() - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivityReader
-
Constructor.
- StelaPrecessionNutationModel - Class in fr.cnes.sirius.patrius.frames.configuration.precessionnutation
-
STELA specific precession/nutation model.
- StelaPrecessionNutationModel() - Constructor for class fr.cnes.sirius.patrius.frames.configuration.precessionnutation.StelaPrecessionNutationModel
-
- StelaRecurrenceZonalAttraction - Class in fr.cnes.sirius.patrius.stela.forces.gravity.recurrence
-
Class representing the Earth zonal harmonics computed using recurrence methods.
- StelaRecurrenceZonalAttraction(PotentialCoefficientsProvider, int) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalAttraction
-
Simple constructor.
- StelaRecurrenceZonalAttraction(PotentialCoefficientsProvider, int, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalAttraction
-
Constructor with J22 flag.
- StelaRecurrenceZonalEquation - Class in fr.cnes.sirius.patrius.stela.forces.gravity.recurrence
-
- StelaRecurrenceZonalEquation(StelaEquinoctialOrbit, int, double[], double[][][][][], double[][][][][]) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.recurrence.StelaRecurrenceZonalEquation
-
Constructor.
- StelaSolarActivityType - Enum in fr.cnes.sirius.patrius.stela.forces.solaractivity
-
Solar activity type enumeration
- StelaSpacecraftFactory - Class in fr.cnes.sirius.patrius.stela
-
Utility class to build Stela spacecrafts
- StelaSpaceObject - Class in fr.cnes.sirius.patrius.stela.spaceobject
-
This class represents the space object used in STELA.
- StelaSpaceObject(String, double, double, double, double, AbstractStelaDragCoef) - Constructor for class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Constructor.
- StelaSpaceObject() - Constructor for class fr.cnes.sirius.patrius.stela.spaceobject.StelaSpaceObject
-
Basis constructor.
- StelaSRPSquaring - Class in fr.cnes.sirius.patrius.stela.forces.radiation
-
This class represents the Stela SRP model, which computes perturbations using the squaring method and the partial
derivatives using the potential approximation.
- StelaSRPSquaring(double, double, double, int, PVCoordinatesProvider) - Constructor for class fr.cnes.sirius.patrius.stela.forces.radiation.StelaSRPSquaring
-
Create an instance of the SRP force Stela model.
- StelaSRPSquaring(double, double, double, int, PVCoordinatesProvider, double, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.radiation.StelaSRPSquaring
-
Create an instance of the SRP force Stela model.
- StelaSRPSquaring(double, double, double, int, PVCoordinatesProvider, double, double, double, int) - Constructor for class fr.cnes.sirius.patrius.stela.forces.radiation.StelaSRPSquaring
-
Create an instance of the SRP force Stela model.
- StelaTesseralAttraction - Class in fr.cnes.sirius.patrius.stela.forces.gravity
-
This class represent the tesseral perturbations
- StelaTesseralAttraction(PotentialCoefficientsProvider) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
-
Constructor.
- StelaTesseralAttraction(PotentialCoefficientsProvider, int, int, double, int) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
-
Constructor.
- StelaThirdBodyAttraction - Class in fr.cnes.sirius.patrius.stela.forces.gravity
-
Class computing third body attraction perturbations.
- StelaThirdBodyAttraction(CelestialPoint, int, int, int) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.StelaThirdBodyAttraction
-
Creates a Stela third body attraction force model.
- StelaVariableDispersedDragCoef - Class in fr.cnes.sirius.patrius.stela.forces.drag
-
Class for drag coefficients depending on space object's height,
with a multiplicative coefficient applied to the read drag coefficients.
- StelaVariableDispersedDragCoef(Map<Double, Double>, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDispersedDragCoef
-
Constructor with default coefficient = 1
- StelaVariableDispersedDragCoef(Map<Double, Double>, double, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDispersedDragCoef
-
Constructor for a Cd model depending on spacecraft altitude.
- StelaVariableDispersedDragCoef(Map<Double, Double>, GeodPosition, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDispersedDragCoef
-
Constructor for a Cd model depending on spacecraft altitude with a
GeodPosition.
- StelaVariableDispersedSolarActivity - Class in fr.cnes.sirius.patrius.stela.forces.solaractivity.variable
-
Class for variable solar activity with a multiplicative coefficient applied.
- StelaVariableDispersedSolarActivity(double, double, SolarActivityDataProvider) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableDispersedSolarActivity
-
Constructor of a variable solar activity with a multiplicative coefficient.
- StelaVariableDispersedSolarActivity(SolarActivityDataProvider) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableDispersedSolarActivity
-
Empty constructor.
- StelaVariableDragCoef - Class in fr.cnes.sirius.patrius.stela.forces.drag
-
Class for drag coefficients depending on space object's altitude.
- StelaVariableDragCoef(Map<Double, Double>, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoef
-
Constructor for a Cd model depending on spacecraft altitude.
- StelaVariableDragCoef(Map<Double, Double>, GeodPosition) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoef
-
Constructor for a Cd model depending on spacecraft altitude.
- StelaVariableDragCoef(StelaDragCoefType, Map<Double, Double>, GeodPosition) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoef
-
Protected constructor which allow a child different dragCoefType
- StelaVariableDragCoefReader - Class in fr.cnes.sirius.patrius.stela.forces.drag
-
Class which reads values of a drag coefficient in a file.
- StelaVariableDragCoefReader() - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoefReader
-
Basis constructor.
- StelaVariableSolarActivity - Class in fr.cnes.sirius.patrius.stela.forces.solaractivity.variable
-
Variable model of solar activity.
- StelaVariableSolarActivity(SolarActivityDataProvider) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Constructor of a variable solar activity model.
- StelaVariableSolarActivity(SolarActivityDataProvider, StelaSolarActivityType) - Constructor for class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaVariableSolarActivity
-
Constructor of a solar activity model.
- StelaZonalAttraction - Class in fr.cnes.sirius.patrius.stela.forces.gravity
-
Class computing Zonal perturbations.
- StelaZonalAttraction(PotentialCoefficientsProvider, int, boolean, int, int, boolean) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
-
Constructor.
- stepAccepted(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.utils.EventState
-
Acknowledge the fact the step has been accepted by the propagator.
- stepAccepted(double, double[]) - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Acknowledge the fact the step has been accepted by the integrator.
- stepCounter - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
-
Step counter for drag computation.
- StepFunction - Class in fr.cnes.sirius.patrius.math.analysis.function
-
- StepFunction(double[], double[]) - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.StepFunction
-
Builds a step function from a list of arguments and the corresponding
values.
- StepHandler - Interface in fr.cnes.sirius.patrius.math.ode.sampling
-
This interface represents a handler that should be called after
each successful step.
- stepHandlers - Variable in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Step handler.
- StepInterpolator - Interface in fr.cnes.sirius.patrius.math.ode.sampling
-
This interface represents an interpolator over the last step
during an ODE integration.
- StepNormalizer - Class in fr.cnes.sirius.patrius.math.ode.sampling
-
- StepNormalizer(double, FixedStepHandler) - Constructor for class fr.cnes.sirius.patrius.math.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizer(double, FixedStepHandler, StepNormalizerMode) - Constructor for class fr.cnes.sirius.patrius.math.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizer(double, FixedStepHandler, StepNormalizerBounds) - Constructor for class fr.cnes.sirius.patrius.math.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizer(double, FixedStepHandler, StepNormalizerMode, StepNormalizerBounds) - Constructor for class fr.cnes.sirius.patrius.math.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizerBounds - Enum in fr.cnes.sirius.patrius.math.ode.sampling
-
- StepNormalizerMode - Enum in fr.cnes.sirius.patrius.math.ode.sampling
-
- stepSize - Variable in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Current stepsize.
- stepStart - Variable in class fr.cnes.sirius.patrius.math.ode.AbstractIntegrator
-
Current step start time.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.bodies.bsp.BSPEphemerisLoader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in interface fr.cnes.sirius.patrius.data.DataLoader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.SolarActivityDataReader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.forces.gravity.potential.PotentialCoefficientsReader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.BulletinBFilesLoader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.EOPC04FilesLoader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.NoEOP1980HistoryLoader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.RapidDataAndPredictionColumnsLoader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.frames.configuration.eop.RapidDataAndPredictionXMLLoader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticModelReader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.models.earth.InterpolationTableLoader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLESeries
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.signalpropagation.ionosphere.R12Loader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.signalpropagation.ionosphere.USKLoader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaVariableDragCoefReader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.stela.forces.solaractivity.variable.StelaPastCyclesSolarActivityReader
-
Check if the loader still accepts new data.
- stillAcceptsData() - Method in class fr.cnes.sirius.patrius.time.UTCTAIHistoryFilesLoader
-
Check if the loader still accepts new data.
- stirlingS2(int, int) - Static method in class fr.cnes.sirius.patrius.math.util.ArithmeticUtils
-
- stop() - Method in class fr.cnes.sirius.patrius.events.utils.EventState
-
Check if the propagation should be stopped at the end of the current step.
- stop() - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Check if the integration should be stopped at the end of the
current step.
- StoppingCondition - Interface in fr.cnes.sirius.patrius.math.genetics
-
Algorithm used to determine when to stop evolution.
- store(T) - Method in class fr.cnes.sirius.patrius.math.optim.BaseMultiStartMultivariateOptimizer
-
Method that will be called in order to store each found optimum.
- store(PointValuePair) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
-
Method that will be called in order to store each found optimum.
- store(PointVectorValuePair) - Method in class fr.cnes.sirius.patrius.math.optim.nonlinear.vector.MultiStartMultivariateVectorOptimizer
-
Method that will be called in order to store each found optimum.
- storeDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.sampling.BasicStepInterpolator
-
Store the current step date.
- StorelessCovariance - Class in fr.cnes.sirius.patrius.math.stat.correlation
-
Covariance implementation that does not require input data to be
stored in memory.
- StorelessCovariance(int) - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.StorelessCovariance
-
Create a bias corrected covariance matrix with a given dimension.
- StorelessCovariance(int, boolean) - Constructor for class fr.cnes.sirius.patrius.math.stat.correlation.StorelessCovariance
-
Create a covariance matrix with a given number of rows and columns and the
indicated bias correction.
- StorelessUnivariateStatistic - Interface in fr.cnes.sirius.patrius.math.stat.descriptive
-
- storeSC(SpacecraftState, SpacecraftState) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
-
Store the current dates and spacecraft states.
- storeState(SpacecraftState, boolean) - Method in class fr.cnes.sirius.patrius.events.utils.EventState
-
Reinitialize event state with provided time and state.
- storeState(double, double[], boolean) - Method in class fr.cnes.sirius.patrius.math.ode.events.EventState
-
Store event state with provided time and state.
- storeTime(double) - Method in class fr.cnes.sirius.patrius.math.ode.sampling.AbstractStepInterpolator
-
Store the current step time.
- StrictAttitudeLegsSequence<L extends AttitudeLeg> - Class in fr.cnes.sirius.patrius.attitudes
-
A “base” implementation of an attitude legs sequence.
- StrictAttitudeLegsSequence() - Constructor for class fr.cnes.sirius.patrius.attitudes.StrictAttitudeLegsSequence
-
- StrictLegsSequence<L extends Leg> - Class in fr.cnes.sirius.patrius.utils.legs
-
A
LegsSequence which does not accept simultaneous or overlapping legs.
- StrictLegsSequence() - Constructor for class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Create a new empty sequence.
- StrictlyConvexMultivariateRealFunction - Interface in fr.cnes.sirius.patrius.math.optim.joptimizer.functions
-
Interface for strictly convex multi-variate real functions.
- strictlyNegative() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Check if instance is strictly less than 0.
- strictlyPositive() - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Check if instance is strictly greater than 0.
- StrictMathWrapper - Class in fr.cnes.sirius.patrius.math.framework
-
StrictMath wrapper.
- StrictMathWrapper() - Constructor for class fr.cnes.sirius.patrius.math.framework.StrictMathWrapper
-
- StringTablePrinter - Class in fr.cnes.sirius.patrius.utils
-
This utility class allows to print a table as a formatted String with dynamic columns widths.
- StringTablePrinter(String[]) - Constructor for class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Constructor to initialize the header.
- StringTablePrinter(String, String[]) - Constructor for class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Constructor to initialize the header and add a centered title to the table.
- StringTablePrinter.StringAlign - Enum in fr.cnes.sirius.patrius.utils
-
Text alignment enumerate.
- sub(AbsoluteDate, AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleLegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfileSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfileSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfileSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.orientations.OrientationAngleProfileSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialProfile
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialSlew
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialSlew
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialSlew
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AngularVelocitiesPolynomialSlew
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfilesSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfilesSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfilesSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.profiles.AttitudeProfilesSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.StrictAttitudeLegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.attitudes.StrictAttitudeLegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.attitudes.StrictAttitudeLegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.attitudes.StrictAttitudeLegsSequence
-
Returns a new sequence extracted.
- sub(L, L) - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate, boolean) - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval, boolean) - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval) - Method in interface fr.cnes.sirius.patrius.utils.legs.LegsSequence
-
Returns a new sequence extracted.
- sub(L, L) - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDate, AbsoluteDate, boolean) - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Returns a new sequence extracted.
- sub(AbsoluteDateInterval, boolean) - Method in class fr.cnes.sirius.patrius.utils.legs.StrictLegsSequence
-
Returns a new sequence extracted.
- sub(T, T) - Method in interface fr.cnes.sirius.patrius.utils.legs.TimeSequence
-
Returns a new sequence extracted.
- subAndCheck(int, int) - Static method in class fr.cnes.sirius.patrius.math.util.ArithmeticUtils
-
Subtract two integers, checking for overflow.
- subAndCheck(long, long) - Static method in class fr.cnes.sirius.patrius.math.util.ArithmeticUtils
-
Subtract two long integers, checking for overflow.
- subdiagonalMultiply(RealMatrix, RealMatrix) - Static method in class fr.cnes.sirius.patrius.math.optim.joptimizer.algebra.AlgebraUtils
-
Return the sub-diagonal result of the multiplication.
- SubHyperplane<S extends Space> - Interface in fr.cnes.sirius.patrius.math.geometry.partitioning
-
This interface represents the remaining parts of an hyperplane after
other parts have been chopped off.
- SubHyperplane.SplitSubHyperplane<U extends Space> - Class in fr.cnes.sirius.patrius.math.geometry.partitioning
-
Class holding the results of the
split method.
- SubLine - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
This class represents a subset of a
Line.
- SubLine(Line, IntervalsSet) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SubLine
-
Simple constructor.
- SubLine(Vector3D, Vector3D) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SubLine
-
Create a sub-line from two endpoints.
- SubLine(Segment) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SubLine
-
Create a sub-line from a segment.
- SubLine - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.twod
-
This class represents a sub-hyperplane for
Line.
- SubLine(Hyperplane<Euclidean2D>, Region<Euclidean1D>) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.SubLine
-
Simple constructor.
- SubLine(Vector2D, Vector2D) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.SubLine
-
Create a sub-line from two endpoints.
- SubLine(Segment) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.SubLine
-
Create a sub-line from a segment.
- SubOrientedPoint - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.oned
-
- SubOrientedPoint(Hyperplane<Euclidean1D>, Region<Euclidean1D>) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.SubOrientedPoint
-
Simple constructor.
- SubPlane - Class in fr.cnes.sirius.patrius.math.geometry.euclidean.threed
-
This class represents a sub-hyperplane for
Plane.
- SubPlane(Hyperplane<Euclidean3D>, Region<Euclidean2D>) - Constructor for class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.SubPlane
-
Simple constructor.
- substituteMostRecentElement(double) - Method in class fr.cnes.sirius.patrius.math.util.ResizableDoubleArray
-
Substitutes value for the most recently added value.
- subtract(double) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
'-' operator.
- subtract(DerivativeStructure) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DerivativeStructure
-
'-' operator.
- subtract(double[], int, double[], int, double[], int) - Method in class fr.cnes.sirius.patrius.math.analysis.differentiation.DSCompiler
-
Perform subtraction of two derivative structures.
- Subtract - Class in fr.cnes.sirius.patrius.math.analysis.function
-
Subtract the second operand from the first.
- Subtract() - Constructor for class fr.cnes.sirius.patrius.math.analysis.function.Subtract
-
- subtract(PolynomialChebyshevFunction) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialChebyshevFunction
-
Subtract a Chebyshev polynomial from the instance.
- subtract(PolynomialFunction) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.PolynomialFunction
-
Subtract a polynomial from the instance.
- subtract(TrigonometricPolynomialFunction) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialFunction
-
Subtract a polynomial to the current polynomial :
- subtract(TrigonometricPolynomialPrimitive) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialPrimitive
-
- subtract(PolynomialFunction) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialPrimitive
-
- subtract(TrigonometricPolynomialFunction) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.TrigonometricPolynomialPrimitive
-
- subtract(Complex) - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Returns a Complex whose value is (this - subtrahend).
- subtract(double) - Method in class fr.cnes.sirius.patrius.math.complex.Complex
-
Returns a Complex whose value is (this - subtrahend).
- subtract(Quaternion, Quaternion) - Static method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Subtracts two quaternions.
- subtract(Quaternion) - Method in class fr.cnes.sirius.patrius.math.complex.Quaternion
-
Subtracts a quaternion from the instance.
- subtract(Dfp) - Method in class fr.cnes.sirius.patrius.math.dfp.Dfp
-
Subtract x from this.
- subtract(T) - Method in interface fr.cnes.sirius.patrius.math.FieldElement
-
Compute this - a.
- subtract(BigInteger) - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Subtracts the value of an
BigInteger from the value of this
BigFraction, returning the result in
reduced form.
- subtract(int) - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Subtracts the value of an integer from the value of this BigFraction, returning the result in
reduced form.
- subtract(long) - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Subtracts the value of a long from the value of this BigFraction, returning the result in reduced
form.
- subtract(BigFraction) - Method in class fr.cnes.sirius.patrius.math.fraction.BigFraction
-
Subtracts the value of another fraction from the value of this one, returning the result in reduced form.
- subtract(Fraction) - Method in class fr.cnes.sirius.patrius.math.fraction.Fraction
-
Subtracts the value of another fraction from the value of this one, returning the result in reduced form.
- subtract(int) - Method in class fr.cnes.sirius.patrius.math.fraction.Fraction
-
Subtract an integer from the fraction.
- subtract(Vector<Euclidean1D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Subtract a vector from the instance.
- subtract(double, Vector<Euclidean1D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.oned.Vector1D
-
Subtract a scaled vector from the instance.
- subtract(FieldVector3D<T>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Subtract a vector from the instance.
- subtract(Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Subtract a vector from the instance.
- subtract(T, FieldVector3D<T>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Subtract a scaled vector from the instance.
- subtract(T, Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Subtract a scaled vector from the instance.
- subtract(double, FieldVector3D<T>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.FieldVector3D
-
Subtract a scaled vector from the instance.
- subtract(Matrix3D) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Matrix3D
-
Computes the subtraction of a Matrix3D to this one
- subtract(Vector<Euclidean3D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Subtract a vector from the instance.
- subtract(double, Vector<Euclidean3D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Vector3D
-
Subtract a scaled vector from the instance.
- subtract(Vector<Euclidean2D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Subtract a vector from the instance.
- subtract(double, Vector<Euclidean2D>) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.twod.Vector2D
-
Subtract a scaled vector from the instance.
- subtract(Vector<S>) - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Subtract a vector from the instance.
- subtract(double, Vector<S>) - Method in interface fr.cnes.sirius.patrius.math.geometry.Vector
-
Subtract a scaled vector from the instance.
- subtract(FieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractFieldMatrix
-
Subtract m from this matrix.
- subtract(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.AbstractRealMatrix
-
Returns the result of subtracting the matrix m from this matrix.
- subtract(Array2DRowFieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowFieldMatrix
-
Subtract m from this matrix.
- subtract(Array2DRowRealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.Array2DRowRealMatrix
-
Returns the result of subtracting a matrix M from this matrix.
- subtract(FieldVector<T>) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Compute this minus v.
- subtract(ArrayFieldVector<T>) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayFieldVector
-
Compute this minus v.
- subtract(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRealVector
-
Subtract v from this vector.
- subtract(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Returns the result of subtracting the matrix m from this matrix.
- subtract(SymmetricMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Returns the result of subtracting the symmetric matrix m from this matrix.
- subtract(DiagonalMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.ArrayRowSymmetricMatrix
-
Returns the result of subtracting the diagonal matrix m from this matrix.
- subtract(FieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Subtract m from this matrix.
- subtract(BlockFieldMatrix<T>) - Method in class fr.cnes.sirius.patrius.math.linear.BlockFieldMatrix
-
Compute this - m.
- subtract(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Returns the result of subtracting the matrix m from this matrix.
- subtract(BlockRealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.BlockRealMatrix
-
Subtract m from this matrix.
- subtract(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Returns the result of subtracting the matrix m from this matrix.
- subtract(SymmetricMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.DecomposedSymmetricPositiveMatrix
-
Returns the result of subtracting the symmetric matrix m from this matrix.
- subtract(RealMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the result of subtracting the matrix m from this matrix.
- subtract(SymmetricMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the result of subtracting the symmetric matrix m from this matrix.
- subtract(DiagonalMatrix) - Method in class fr.cnes.sirius.patrius.math.linear.DiagonalMatrix
-
Returns the result of subtracting the diagonal matrix m from this matrix.
- subtract(FieldMatrix<T>) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldMatrix
-
Subtract m from this matrix.
- subtract(FieldVector<T>) - Method in interface fr.cnes.sirius.patrius.math.linear.FieldVector
-
Compute this minus v.
- subtract(RealMatrix) - Method in interface fr.cnes.sirius.patrius.math.linear.RealMatrix
-
Returns the result of subtracting the matrix m from this matrix.
- subtract(RealVector) - Method in class fr.cnes.sirius.patrius.math.linear.RealVector
-
Subtract v from this vector.
- subtract(SymmetricMatrix) - Method in interface fr.cnes.sirius.patrius.math.linear.SymmetricMatrix
-
Returns the result of subtracting the symmetric matrix m from this matrix.
- subtract(double) - Method in interface fr.cnes.sirius.patrius.math.RealFieldElement
-
'-' operator.
- subtract(BigReal) - Method in class fr.cnes.sirius.patrius.math.util.BigReal
-
Compute this - a.
- subtract(Decimal64) - Method in class fr.cnes.sirius.patrius.math.util.Decimal64
-
Compute this - a.
- subtractExact(int, int) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Subtract two numbers, detecting overflows.
- subtractExact(long, long) - Static method in class fr.cnes.sirius.patrius.math.util.FastMath
-
Subtract two numbers, detecting overflows.
- subtractOffset(AngularCoordinates, boolean) - Method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Subtract an offset from the instance.
- subtractOffset(AngularCoordinates) - Method in class fr.cnes.sirius.patrius.utils.AngularCoordinates
-
Subtract an offset from the instance.
- subtractOffset(AngularCoordinates) - Method in class fr.cnes.sirius.patrius.utils.TimeStampedAngularCoordinates
-
Subtract an offset from the instance.
- subtractOffset(AngularCoordinates, boolean) - Method in class fr.cnes.sirius.patrius.utils.TimeStampedAngularCoordinates
-
Subtract an offset from the instance.
- SUCCESS - Static variable in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationResponse
-
Succes variable
- successor - Variable in class fr.cnes.sirius.patrius.math.optim.joptimizer.optimizers.OptimizationRequestHandler
-
optimization request handler
- sum(Screw, Screw) - Static method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Screw
-
Calculate the sum of this and screw, expressed in this objects origin.
- sum(Screw) - Method in class fr.cnes.sirius.patrius.math.geometry.euclidean.threed.Screw
-
Calculate the sum of this and screw, expressed in this objects origin.
- Sum - Class in fr.cnes.sirius.patrius.math.stat.descriptive.summary
-
Returns the sum of the available values.
- Sum() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Sum
-
Create a Sum instance
- Sum(Sum) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.summary.Sum
-
Copy constructor, creates a new Sum identical
to the original
- sum(double[]) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the sum of the values in the input array, or Double.NaN if the array is empty.
- sum(double[], int, int) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the sum of the entries in the specified portion of
the input array, or Double.NaN if the designated subarray
is empty.
- sum(Wrench, Wrench) - Static method in class fr.cnes.sirius.patrius.wrenches.Wrench
-
Sum of two wrenches.
- sumDeltaMinusDeltaSum(double, double) - Static method in class fr.cnes.sirius.patrius.math.special.Beta
-
Returns the value of Δ(p) + Δ(q) - Δ(p + q), with p, q ≥ 10.
- sumDifference(double[], double[]) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the sum of the (signed) differences between corresponding elements of the
input arrays -- i.e., sum(sample1[i] - sample2[i]).
- sumLog(double[]) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the sum of the natural logs of the entries in the input array, or Double.NaN if the array is
empty.
- sumLog(double[], int, int) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the sum of the natural logs of the entries in the specified portion of
the input array, or Double.NaN if the designated subarray
is empty.
- SUMMARY_FORMAT - Static variable in class fr.cnes.sirius.patrius.math.linear.MatrixUtils
-
Summary visual format for
RealMatrix objects displayed on several rows.
- SummaryStatistics - Class in fr.cnes.sirius.patrius.math.stat.descriptive
-
Computes summary statistics for a stream of data values added using the
addValue method.
- SummaryStatistics() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
Construct a SummaryStatistics instance
- SummaryStatistics(SummaryStatistics) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.SummaryStatistics
-
A copy constructor.
- SumOfLogs - Class in fr.cnes.sirius.patrius.math.stat.descriptive.summary
-
Returns the sum of the natural logs for this collection of values.
- SumOfLogs() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfLogs
-
Create a SumOfLogs instance
- SumOfLogs(SumOfLogs) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfLogs
-
Copy constructor, creates a new SumOfLogs identical
to the original
- SumOfSquares - Class in fr.cnes.sirius.patrius.math.stat.descriptive.summary
-
Returns the sum of the squares of the available values.
- SumOfSquares() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfSquares
-
Create a SumOfSquares instance
- SumOfSquares(SumOfSquares) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.summary.SumOfSquares
-
Copy constructor, creates a new SumOfSquares identical
to the original
- sumSq(double[]) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the sum of the squares of the entries in the input array, or Double.NaN if the array is
empty.
- sumSq(double[], int, int) - Static method in class fr.cnes.sirius.patrius.math.stat.StatUtils
-
Returns the sum of the squares of the entries in the specified portion of
the input array, or Double.NaN if the designated subarray
is empty.
- SUN - Static variable in class fr.cnes.sirius.patrius.bodies.CelestialBodyFactory
-
Predefined name for Sun.
- sun - Variable in class fr.cnes.sirius.patrius.forces.atmospheres.AbstractDTM
-
Sun position.
- SUN_RADIUS - Static variable in interface fr.cnes.sirius.patrius.utils.Constants
-
Sun radius: 695500000 m.
- sunCenter10 - Variable in enum fr.cnes.sirius.patrius.bodies.MeeusSun.MODEL
-
Constant of the Sun's equation of center C (rad).
- sunCenter11 - Variable in enum fr.cnes.sirius.patrius.bodies.MeeusSun.MODEL
-
Constant of the Sun's equation of center C (rad).
- sunCenter12 - Variable in enum fr.cnes.sirius.patrius.bodies.MeeusSun.MODEL
-
Constant of the Sun's equation of center C (rad).
- sunCenter20 - Variable in enum fr.cnes.sirius.patrius.bodies.MeeusSun.MODEL
-
Constant of the Sun's equation of center C (rad).
- sunCenter21 - Variable in enum fr.cnes.sirius.patrius.bodies.MeeusSun.MODEL
-
Constant of the Sun's equation of center C (rad).
- sunCenter30 - Variable in enum fr.cnes.sirius.patrius.bodies.MeeusSun.MODEL
-
Constant of the Sun's equation of center C (rad).
- sunEarthCoeff - Variable in enum fr.cnes.sirius.patrius.bodies.MeeusSun.MODEL
-
Coefficient from the Earth to the Sun constant (AU).
- sunLongToJ2000 - Variable in enum fr.cnes.sirius.patrius.bodies.MeeusSun.MODEL
-
Sun longitude in J2000.
- SunPointing - Class in fr.cnes.sirius.patrius.attitudes
-
This class implements a Sun pointing attitude law.
- SunPointing(Vector3D, Vector3D) - Constructor for class fr.cnes.sirius.patrius.attitudes.SunPointing
-
Constructor of the sun pointing attitude law.
- SunPointing(CelestialBodyFrame, Vector3D, Vector3D) - Constructor for class fr.cnes.sirius.patrius.attitudes.SunPointing
-
Constructor of the sun pointing attitude law.
- SunPointing(Vector3D, Vector3D, CelestialBody) - Constructor for class fr.cnes.sirius.patrius.attitudes.SunPointing
-
Constructor of the sun pointing attitude law.
- SunPointing(CelestialBodyFrame, Vector3D, Vector3D, PVCoordinatesProvider) - Constructor for class fr.cnes.sirius.patrius.attitudes.SunPointing
-
Constructor of the sun pointing attitude law.
- supplementaryAngle(double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.math.interval.AngleTools
-
Computes the supplementary (PI - angle) of the input angle, and then tries to express it in the
input interval.
- supportsJacobianParameter(Parameter) - Method in interface fr.cnes.sirius.patrius.math.parameter.IJacobiansParameterizable
-
Check if a jacobian parameter is supported.
- supportsJacobianParameter(Parameter) - Method in class fr.cnes.sirius.patrius.math.parameter.JacobiansParameterizable
-
Check if a jacobian parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AbstractAeroCoeff1D
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffByAoAAndMach
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.assembly.models.aerocoeffs.AeroCoeffConstant
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.assembly.models.cook.CnCookModel
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.assembly.models.cook.CtCookModel
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.math.analysis.polynomials.ZernikePolynomial
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in interface fr.cnes.sirius.patrius.math.parameter.IParameterizable
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.math.parameter.LinearCombinationFunction
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.math.parameter.Parameterizable
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.signalpropagation.ionosphere.BentModel
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AstronomicalRefractionModel
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.AzoulayModel
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.FixedDelayModel
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.MariniMurrayModel
-
Check if a parameter is supported.
- supportsParameter(Parameter) - Method in class fr.cnes.sirius.patrius.signalpropagation.troposphere.SaastamoinenModel
-
Check if a parameter is supported.
- supportsTimeTransform() - Method in class fr.cnes.sirius.patrius.models.earth.GeoMagneticField
-
Indicates whether this model supports time transformation or not.
- SurfaceDistanceDetector - Class in fr.cnes.sirius.patrius.events.detectors
-
Detects when the distance from the spacecraft to the surface of a given body reaches a predetermined value.
- SurfaceDistanceDetector(CelestialBody, double, SurfaceDistanceDetector.BodyDistanceType) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Constructor for a DistanceDetector instance.
- SurfaceDistanceDetector(CelestialBody, double, SurfaceDistanceDetector.BodyDistanceType, double, double) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Constructor for a DistanceDetector instance with additional maxCheck and threshold parameters
The default implementation behavior is to stop propagation when the distance is
reached.
- SurfaceDistanceDetector(CelestialBody, double, SurfaceDistanceDetector.BodyDistanceType, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Constructor for a DistanceDetector instance with complementary parameters.
- SurfaceDistanceDetector(CelestialBody, double, SurfaceDistanceDetector.BodyDistanceType, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Constructor for a DistanceDetector instance with complementary parameters.
- SurfaceDistanceDetector(CelestialBody, double, SurfaceDistanceDetector.BodyDistanceType, int, double, double, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.detectors.SurfaceDistanceDetector
-
Build a new altitude detector with slope selection.
- SurfaceDistanceDetector.BodyDistanceType - Enum in fr.cnes.sirius.patrius.events.detectors
-
Body distance type.
- switchLastLineBold() - Method in class fr.cnes.sirius.patrius.utils.StringTablePrinter
-
Change the last table line into a line full of bold separators.
- sxpInitialize() - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
Initialization proper to each propagator (SGP or SDP).
- sxpPropagate(double) - Method in class fr.cnes.sirius.patrius.propagation.analytical.tle.TLEPropagator
-
Propagation proper to each propagator (SGP or SDP).
- SymmetricMatrix - Interface in fr.cnes.sirius.patrius.math.linear
-
Interface for symmetric matrices.
- SymmetricPositiveMatrix - Interface in fr.cnes.sirius.patrius.math.linear
-
Interface for symmetric positive semi-definite matrices.
- SymmLQ - Class in fr.cnes.sirius.patrius.math.linear
-
- SymmLQ(int, double, boolean) - Constructor for class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
- SymmLQ(IterationManager, double, boolean) - Constructor for class fr.cnes.sirius.patrius.math.linear.SymmLQ
-
- SynchronizedDescriptiveStatistics - Class in fr.cnes.sirius.patrius.math.stat.descriptive
-
- SynchronizedDescriptiveStatistics() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Construct an instance with infinite window
- SynchronizedDescriptiveStatistics(int) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
Construct an instance with finite window
- SynchronizedDescriptiveStatistics(SynchronizedDescriptiveStatistics) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedDescriptiveStatistics
-
A copy constructor.
- SynchronizedMultivariateSummaryStatistics - Class in fr.cnes.sirius.patrius.math.stat.descriptive
-
- SynchronizedMultivariateSummaryStatistics(int, boolean) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
-
Construct a SynchronizedMultivariateSummaryStatistics instance
- SynchronizedRandomGenerator - Class in fr.cnes.sirius.patrius.math.random
-
Any
RandomGenerator implementation can be thread-safe if it
is used through an instance of this class.
- SynchronizedRandomGenerator(RandomGenerator) - Constructor for class fr.cnes.sirius.patrius.math.random.SynchronizedRandomGenerator
-
Creates a synchronized wrapper for the given RandomGenerator instance.
- SynchronizedSummaryStatistics - Class in fr.cnes.sirius.patrius.math.stat.descriptive
-
Implementation of
SummaryStatistics that
is safe to use in a multithreaded environment.
- SynchronizedSummaryStatistics() - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
Construct a SynchronizedSummaryStatistics instance
- SynchronizedSummaryStatistics(SynchronizedSummaryStatistics) - Constructor for class fr.cnes.sirius.patrius.math.stat.descriptive.SynchronizedSummaryStatistics
-
A copy constructor.
- SynodicFrame - Class in fr.cnes.sirius.patrius.frames
-
Synodic frame.
- SynodicFrame(LocalOrbitalFrame, String, double) - Constructor for class fr.cnes.sirius.patrius.frames.SynodicFrame
-
Constructor.