A B C D E F G H I J K L M N O P Q R S T U V W X Y Z

A

A - Static variable in class org.orekit.parameter.LinearFunction
Default function slope name.
a - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
final semi major axis.
A0 - Static variable in class org.orekit.forces.radiation.KnockeRiesModel
coefficient a0 of Knocke-Ries model.
a0dp - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
original recovered semi major axis.
A2 - Static variable in class org.orekit.forces.radiation.KnockeRiesModel
coefficient a2 of Knocke-Ries model.
abs() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
absolute value.
Abs - Class in org.apache.commons.math3.analysis.function
Absolute value function.
Abs() - Constructor for class org.apache.commons.math3.analysis.function.Abs
 
abs() - Method in class org.apache.commons.math3.complex.Complex
Return the absolute value of this complex number.
abs() - Method in class org.apache.commons.math3.dfp.Dfp
Get the absolute value of instance.
abs() - Method in class org.apache.commons.math3.fraction.BigFraction
Returns the absolute value of this BigFraction.
abs() - Method in class org.apache.commons.math3.fraction.Fraction
Returns the absolute value of this fraction.
abs() - Method in interface org.apache.commons.math3.RealFieldElement
absolute value.
abs(int) - Static method in class org.apache.commons.math3.util.FastMath
Absolute value.
abs(long) - Static method in class org.apache.commons.math3.util.FastMath
Absolute value.
abs(float) - Static method in class org.apache.commons.math3.util.FastMath
Absolute value.
abs(double) - Static method in class org.apache.commons.math3.util.FastMath
Absolute value.
AbsoluteDate - Class in org.orekit.time
This class represents a specific instant in time.
AbsoluteDate() - Constructor for class org.orekit.time.AbsoluteDate
Create an instance with a default value (AbsoluteDate.J2000_EPOCH).
AbsoluteDate(long, double) - Constructor for class org.orekit.time.AbsoluteDate
Create an instance with epoch and offset directly.
WARNING : this constructor is meant for advanced users only, since epoch and offset have special constraints and values that are not checked or enforced here.
AbsoluteDate(String, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from a location (parsed from a string) in a time scale.
AbsoluteDate(DateTimeComponents, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from a location in a time scale.
AbsoluteDate(DateComponents, TimeComponents, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from a location in a time scale.
AbsoluteDate(int, int, int, int, int, double, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from a location in a time scale.
AbsoluteDate(int, Month, int, int, int, double, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from a location in a time scale.
AbsoluteDate(DateComponents, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from a location in a time scale.
AbsoluteDate(int, int, int, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from a location in a time scale.
AbsoluteDate(int, Month, int, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from a location in a time scale.
AbsoluteDate(Date, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from a location in a time scale.
AbsoluteDate(AbsoluteDate, double) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from an elapsed duration since to another instant.
AbsoluteDate(AbsoluteDate, double, TimeScale) - Constructor for class org.orekit.time.AbsoluteDate
Build an instance from an apparent clock offset with respect to another instant in the perspective of a specific time scale.
AbsoluteDateInterval - Class in org.orekit.utils
This class implements an interval based on the AbsoluteDate class,
using the ComparableInterval class.
AbsoluteDateInterval(IntervalEndpointType, AbsoluteDate, AbsoluteDate, IntervalEndpointType) - Constructor for class org.orekit.utils.AbsoluteDateInterval
Constructor for an AbsoluteDate interval.
AbsoluteDateIntervalsList - Class in org.orekit.utils
This class represents a list of objects AbsoluteDateInterval.
It extends a TreeSet of AbsoluteDateInterval instances ; as the AbsoluteDateInterval objects implement the ComparableInterval class, the list is an ordered collection of time intervals.
AbsoluteDateIntervalsList() - Constructor for class org.orekit.utils.AbsoluteDateIntervalsList
 
ABSORPTION_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
Parameter name for absorption coefficient.
ABSORPTION_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
Parameter name for absorption coefficient.
AbstractAttitudeEphemerisGenerator - Class in org.orekit.attitudes
This abstract class handles the generation of attitude ephemeris from an attitude laws sequence AttitudeLegsSequence.
The ephemeris generation can be done using a fixed time step or a variable time step, setting the generation time interval (the default value is the time interval of the sequence), and the treatment to apply to the transition points of the sequence (ignore them, compute the attitude of the initial date of the laws, compute the attitude of the initial and final date of the laws).
AbstractAttitudeEphemerisGenerator(AttitudeLegsSequence, int) - Constructor for class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
Simple constructor.
AbstractAttitudeLaw - Class in org.orekit.attitudes
This abstract class gather all common features to classes implementing the AttitudeLaw interface.
AbstractAttitudeLaw() - Constructor for class org.orekit.attitudes.AbstractAttitudeLaw
 
AbstractBoundedPVProvider - Class in org.orekit.utils
This abstract class shall be extended to provides a PVCoordinates provider based on manipulation of PVCoordinates ephemeris.
AbstractBoundedPVProvider(PVCoordinates[], Frame, AbsoluteDate[], ISearchIndex) - Constructor for class org.orekit.utils.AbstractBoundedPVProvider
Instantiation of AbstractBoundedPVProvider attributes.
AbstractBoundedPVProvider(SpacecraftState[], ISearchIndex) - Constructor for class org.orekit.utils.AbstractBoundedPVProvider
Creates an instance of AbstractBoundedPVProvider from a SpacecraftState table
AbstractCelestialBody - Class in org.orekit.bodies
Abstract implementation of the CelestialBody interface.
AbstractCelestialBody(String, double, IAUPole, Frame, String, String) - Constructor for class org.orekit.bodies.AbstractCelestialBody
Build an instance and the underlying frame.
AbstractConvergenceChecker<PAIR> - Class in org.apache.commons.math3.optim
Base class for all convergence checker implementations.
AbstractConvergenceChecker(double, double) - Constructor for class org.apache.commons.math3.optim.AbstractConvergenceChecker
Build an instance with a specified thresholds.
AbstractConvergenceChecker<PAIR> - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
AbstractConvergenceChecker() - Constructor for class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated. in 3.1 (to be removed in 4.0). Convergence thresholds are problem-dependent. As this class is intended for users who want to set their own convergence criterion instead of relying on an algorithm's default procedure, they should also set the thresholds appropriately (cf. MATH-798).
AbstractConvergenceChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated. Build an instance with a specified thresholds.
AbstractDataLoader - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This abstract class is the base for a DataLoader.
AbstractDataLoader() - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.AbstractDataLoader
 
AbstractDateIntervalFunction - Class in org.orekit.propagation.analytical.twod
Abstract class for piecewise function of date.
AbstractDateIntervalFunction(AbsoluteDate[]) - Constructor for class org.orekit.propagation.analytical.twod.AbstractDateIntervalFunction
Constructor.
AbstractDateIntervalFunction(AbstractDateIntervalFunction) - Constructor for class org.orekit.propagation.analytical.twod.AbstractDateIntervalFunction
Clone constructor.
AbstractDetector - Class in org.orekit.propagation.events
Common parts shared by several events finders.
AbstractDetector(double, double) - Constructor for class org.orekit.propagation.events.AbstractDetector
Build a new instance.
AbstractDetector(int, double, double) - Constructor for class org.orekit.propagation.events.AbstractDetector
Build a new instance.
AbstractDetectorWithTropoCorrection - Class in fr.cnes.sirius.patrius.events.sensor
Abstract event detector using a station elevation correction.
AbstractDetectorWithTropoCorrection(GeometricStationAntenna, AngularCorrection, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.AbstractDetectorWithTropoCorrection
Constructor for the abstract event detector using a station elevation correction.
AbstractDifferentiableOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated. As of 3.1 (to be removed in 4.0).
AbstractDifferentiableOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.AbstractDifferentiableOptimizer
Deprecated.  
AbstractDifferentiableUnivariateSolver - Class in org.apache.commons.math3.analysis.solvers
Deprecated. as of 3.1, replaced by AbstractUnivariateDifferentiableSolver
AbstractDifferentiableUnivariateSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractDifferentiableUnivariateSolver
Deprecated. Construct a solver with given absolute accuracy.
AbstractDifferentiableUnivariateSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractDifferentiableUnivariateSolver
Deprecated. Construct a solver with given accuracies.
AbstractEllipse - Class in org.apache.commons.math3.geometry.euclidean.threed
This is an abstract describing class for an ellipse in 3D space, with some algorithm to compute intersections and distances to some other objects.
AbstractEllipse(Vector3D, Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
Build an ellipse in the 3D space from its center, normal vector, approximative U vector of the local frame, and two radiuses.
AbstractEOPHistory - Class in org.orekit.frames.configuration.eop
This class loads any kind of Earth Orientation Parameter data throughout a large time range.
AbstractEOPHistory(EOPInterpolators) - Constructor for class org.orekit.frames.configuration.eop.AbstractEOPHistory
Simple constructor.
AbstractEphemeris - Class in org.orekit.propagation.precomputed
This class handles tabulated spacecraft states entries (either from a pv coordinates provider and an attitude provider or a spacecraft states array).
AbstractEphemeris(SpacecraftState[]) - Constructor for class org.orekit.propagation.precomputed.AbstractEphemeris
Simple constructor of class AbstractEphemeris, with interpolation order equal to 2.
AbstractEphemeris(SpacecraftState[], int) - Constructor for class org.orekit.propagation.precomputed.AbstractEphemeris
Simple constructor of class AbstractEphemeris with defined interpolation order.
AbstractEphemeris(SpacecraftState[], ISearchIndex) - Constructor for class org.orekit.propagation.precomputed.AbstractEphemeris
Constructor of class AbstractEphemeris where a search index algorithm is passed on the constructor and the order is by default equal to 2.
AbstractEphemeris(SpacecraftState[], int, ISearchIndex) - Constructor for class org.orekit.propagation.precomputed.AbstractEphemeris
Constructor of class AbstractEphemeris where a search index algorithm is passed on the constructor.
AbstractFastFourierTransformer - Class in org.apache.commons.math3.transform
This abstract class is common to all FFT algorithms of this library.
AbstractFastFourierTransformer(DftNormalization) - Constructor for class org.apache.commons.math3.transform.AbstractFastFourierTransformer
Creates a new instance of this class, with various normalization conventions.
AbstractFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Basic implementation of FieldMatrix methods regardless of the underlying storage.
AbstractFieldMatrix() - Constructor for class org.apache.commons.math3.linear.AbstractFieldMatrix
Constructor for use with Serializable
AbstractFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math3.linear.AbstractFieldMatrix
Creates a matrix with no data
AbstractFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.AbstractFieldMatrix
Create a new FieldMatrix with the supplied row and column dimensions.
AbstractFormat - Class in org.apache.commons.math3.fraction
Common part shared by both FractionFormat and BigFractionFormat.
AbstractFormat() - Constructor for class org.apache.commons.math3.fraction.AbstractFormat
Create an improper formatting instance with the default number format for the numerator and denominator.
AbstractFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.AbstractFormat
Create an improper formatting instance with a custom number format for both the numerator and denominator.
AbstractFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.AbstractFormat
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
AbstractInertiaProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is the abstract class for all inertia properties : those properties can provide the inertia matrix and mass center of the part.
AbstractInertiaProperty(Vector3D, Matrix3D, MassProperty) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
Constructor for the abstract inertia property.
AbstractInertiaProperty(Vector3D, Matrix3D, Vector3D, MassProperty) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
Constructor for the abstract inertia property.
AbstractIntegerDistribution - Class in org.apache.commons.math3.distribution
Base class for integer-valued discrete distributions.
AbstractIntegerDistribution() - Constructor for class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Deprecated. As of 3.1, to be removed in 4.0. Please use AbstractIntegerDistribution.AbstractIntegerDistribution(RandomGenerator) instead.
AbstractIntegerDistribution(RandomGenerator) - Constructor for class org.apache.commons.math3.distribution.AbstractIntegerDistribution
 
AbstractIntegrator - Class in org.apache.commons.math3.ode
Base class managing common boilerplate for all integrators.
AbstractIntegrator(String) - Constructor for class org.apache.commons.math3.ode.AbstractIntegrator
Build an instance.
AbstractIntegrator() - Constructor for class org.apache.commons.math3.ode.AbstractIntegrator
Build an instance with a null name.
AbstractInterval - Class in fr.cnes.sirius.patrius.utils
- very simple class to represent an interval only by its ending point nature : this is what all intervals have in common.
AbstractInterval() - Constructor for class fr.cnes.sirius.patrius.utils.AbstractInterval
 
AbstractLeastSquaresOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector.jacobian
Base class for implementing least-squares optimizers.
AbstractLeastSquaresOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
 
AbstractLeastSquaresOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated. As of 3.1 (to be removed in 4.0).
AbstractLeastSquaresOptimizer() - Constructor for class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. See SimpleValueChecker.SimpleValueChecker()
AbstractLeastSquaresOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.  
AbstractLinearIntervalsFunction - Class in org.apache.commons.math3.analysis.interpolation
Abstract class for linear interpolation.
AbstractLinearIntervalsFunction() - Constructor for class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
 
AbstractLinearOptimizer - Class in org.apache.commons.math3.optimization.linear
Deprecated. As of 3.1 (to be removed in 4.0).
AbstractLinearOptimizer() - Constructor for class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated. Simple constructor with default settings.
AbstractListChromosome<T> - Class in org.apache.commons.math3.genetics
Chromosome represented by an immutable list of a fixed length.
AbstractListChromosome(List<T>) - Constructor for class org.apache.commons.math3.genetics.AbstractListChromosome
Constructor.
AbstractListChromosome(T[]) - Constructor for class org.apache.commons.math3.genetics.AbstractListChromosome
Constructor.
AbstractLyddanePropagator - Class in org.orekit.propagation.analytical
Abstract Lyddane propagator.
AbstractLyddanePropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, AttitudeProvider, AttitudeProvider, MassProvider) - Constructor for class org.orekit.propagation.analytical.AbstractLyddanePropagator
Generic constructor.
AbstractLyddanePropagator.LyddaneParametersType - Enum in org.orekit.propagation.analytical
Lyddane parameters types.
AbstractMSISE2000SolarData - Class in org.orekit.forces.atmospheres.solarActivity.specialized
This abstract class represents a solar data container adapted for the MSISE2000 atmosphere model.
AbstractMSISE2000SolarData(SolarActivityDataProvider) - Constructor for class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Constructor.
AbstractMultipleLinearRegression - Class in org.apache.commons.math3.stat.regression
Abstract base class for implementations of MultipleLinearRegression.
AbstractMultipleLinearRegression() - Constructor for class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
 
AbstractMultivariateRealDistribution - Class in org.apache.commons.math3.distribution
Base class for multivariate probability distributions.
AbstractMultivariateRealDistribution(RandomGenerator, int) - Constructor for class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
 
AbstractOrbitalParameters - Class in org.orekit.orbits.orbitalparameters
Abstract class for orbital parameters.
AbstractOrbitalParameters(double) - Constructor for class org.orekit.orbits.orbitalparameters.AbstractOrbitalParameters
Constructor.
AbstractOrientationFunction - Class in org.orekit.attitudes.kinematics
This abstract class is a time-dependent function representing an orientation.
AbstractOrientationFunction(AbsoluteDate) - Constructor for class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Constructor setting a default finite differences differentiator.
AbstractOrientationFunction(AbsoluteDate, UnivariateVectorFunctionDifferentiator) - Constructor for class org.orekit.attitudes.kinematics.AbstractOrientationFunction
 
AbstractParameterizable - Class in org.apache.commons.math3.ode
This abstract class provides boilerplate parameters list.
AbstractParameterizable(String...) - Constructor for class org.apache.commons.math3.ode.AbstractParameterizable
Simple constructor.
AbstractParameterizable(Collection<String>) - Constructor for class org.apache.commons.math3.ode.AbstractParameterizable
Simple constructor.
AbstractPolynomialSolver - Class in org.apache.commons.math3.analysis.solvers
Base class for solvers.
AbstractPolynomialSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
Construct a solver with given absolute accuracy.
AbstractPolynomialSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
Construct a solver with given accuracies.
AbstractPolynomialSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
Construct a solver with given accuracies.
AbstractProjection - Class in fr.cnes.sirius.patrius.projections
Abstract class for projections.
AbstractProjection(GeodeticPoint, ProjectionEllipsoid) - Constructor for class fr.cnes.sirius.patrius.projections.AbstractProjection
Constructor.
AbstractPropagator - Class in org.orekit.propagation
Common handling of Propagator methods for analytical propagators.
AbstractPropagator(AttitudeProvider) - Constructor for class org.orekit.propagation.AbstractPropagator
Build a new instance.
AbstractPropagator(AttitudeProvider, AttitudeProvider) - Constructor for class org.orekit.propagation.AbstractPropagator
Build a new instance.
AbstractRandomGenerator - Class in org.apache.commons.math3.random
Abstract class implementing the RandomGenerator interface.
AbstractRandomGenerator() - Constructor for class org.apache.commons.math3.random.AbstractRandomGenerator
Construct a RandomGenerator.
AbstractRealDistribution - Class in org.apache.commons.math3.distribution
Base class for probability distributions on the reals.
AbstractRealDistribution() - Constructor for class org.apache.commons.math3.distribution.AbstractRealDistribution
Deprecated. As of 3.1, to be removed in 4.0. Please use AbstractRealDistribution.AbstractRealDistribution(RandomGenerator) instead.
AbstractRealDistribution(RandomGenerator) - Constructor for class org.apache.commons.math3.distribution.AbstractRealDistribution
 
AbstractRealMatrix - Class in org.apache.commons.math3.linear
Basic implementation of RealMatrix methods regardless of the underlying storage.
AbstractRealMatrix() - Constructor for class org.apache.commons.math3.linear.AbstractRealMatrix
Creates a matrix with no data
AbstractRealMatrix(int, int) - Constructor for class org.apache.commons.math3.linear.AbstractRealMatrix
Create a new RealMatrix with the supplied row and column dimensions.
AbstractRegion<S extends Space,T extends Space> - Class in org.apache.commons.math3.geometry.partitioning
Abstract class for all regions, independently of geometry type or dimension.
AbstractRegion() - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Build a region representing the whole space.
AbstractRegion(BSPTree<S>) - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Build a region from an inside/outside BSP tree.
AbstractRegion(Collection<SubHyperplane<S>>) - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Build a Region from a Boundary REPresentation (B-rep).
AbstractRegion(Hyperplane<S>[]) - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Build a convex region from an array of bounding hyperplanes.
AbstractScalarDifferentiableOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated. As of 3.1 (to be removed in 4.0).
AbstractScalarDifferentiableOptimizer() - Constructor for class org.apache.commons.math3.optimization.general.AbstractScalarDifferentiableOptimizer
Deprecated. See SimpleValueChecker.SimpleValueChecker()
AbstractScalarDifferentiableOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.AbstractScalarDifferentiableOptimizer
Deprecated.  
AbstractSearchIndex - Class in org.apache.commons.math3.utils
Abstract class for index search algorithm with a coupled dichotomy-BinarySearch algorithms.
AbstractSearchIndex(double[]) - Constructor for class org.apache.commons.math3.utils.AbstractSearchIndex
Default constructor with default CLOSED_OPEN convention.
AbstractSearchIndex(double[], ISearchIndex.SearchIndexIntervalConvention) - Constructor for class org.apache.commons.math3.utils.AbstractSearchIndex
Constructor with defined interval convention.
AbstractSimpleParallelTaskImpl - Class in fr.cnes.sirius.validate.parallel
Simple, abstract implementation for a ParallelTask.
AbstractSimpleParallelTaskImpl(int) - Constructor for class fr.cnes.sirius.validate.parallel.AbstractSimpleParallelTaskImpl
Constructor with instance id parameter.
AbstractSimplex - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This class implements the simplex concept.
AbstractSimplex(int) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Build a unit hypercube simplex.
AbstractSimplex(int, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Build a hypercube simplex with the given side length.
AbstractSimplex(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
The start configuration for simplex is built from a box parallel to the canonical axes of the space.
AbstractSimplex(double[][]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
The real initial simplex will be set up by moving the reference simplex such that its first point is located at the start point of the optimization.
AbstractSimplex - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
AbstractSimplex(int) - Constructor for class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Build a unit hypercube simplex.
AbstractSimplex(int, double) - Constructor for class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Build a hypercube simplex with the given side length.
AbstractSimplex(double[]) - Constructor for class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. The start configuration for simplex is built from a box parallel to the canonical axes of the space.
AbstractSimplex(double[][]) - Constructor for class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. The real initial simplex will be set up by moving the reference simplex such that its first point is located at the start point of the optimization.
AbstractSlew - Class in org.orekit.attitudes
This abstract class is the basic implementation of the Slew interface.
AbstractSlew(AttitudeProvider, AttitudeProvider, AbsoluteDate, AbsoluteDate) - Constructor for class org.orekit.attitudes.AbstractSlew
Builds a slew when its interval of validity is known.
AbstractStelaGaussContribution - Class in fr.cnes.sirius.patrius.stela.forces
Abstract Class for the computation of Gauss Equations and its derivatives
AbstractStelaGaussContribution() - Constructor for class fr.cnes.sirius.patrius.stela.forces.AbstractStelaGaussContribution
Constructor of the class
AbstractStelaLagrangeContribution - Class in fr.cnes.sirius.patrius.stela.forces
This abstract class represents a force with Lagrange attribute, to be used in a StelaGTOPropagator.
AbstractStelaLagrangeContribution() - Constructor for class fr.cnes.sirius.patrius.stela.forces.AbstractStelaLagrangeContribution
Constructor of the class
AbstractStepInterpolator - Class in org.apache.commons.math3.ode.sampling
This abstract class represents an interpolator over the last step during an ODE integration.
AbstractStepInterpolator() - Constructor for class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Simple constructor.
AbstractStepInterpolator(double[], boolean, EquationsMapper, EquationsMapper[]) - Constructor for class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Simple constructor.
AbstractStepInterpolator(AbstractStepInterpolator) - Constructor for class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Copy constructor.
AbstractStorelessUnivariateStatistic - Class in org.apache.commons.math3.stat.descriptive
Abstract implementation of the StorelessUnivariateStatistic interface.
AbstractStorelessUnivariateStatistic() - Constructor for class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
 
AbstractSubHyperplane<S extends Space,T extends Space> - Class in org.apache.commons.math3.geometry.partitioning
This class implements the dimension-independent parts of SubHyperplane.
AbstractSubHyperplane(Hyperplane<S>, Region<T>) - Constructor for class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Build a sub-hyperplane from an hyperplane and a region.
AbstractTides - Class in org.orekit.forces.gravity.tides
Common handling of ForceModel methods for tides models.
AbstractTides(Frame, double, double, int, int) - Constructor for class org.orekit.forces.gravity.tides.AbstractTides
Build a new instance.
AbstractTides(Frame, double, double, int, int, int, int) - Constructor for class org.orekit.forces.gravity.tides.AbstractTides
Build a new instance.
AbstractTides(Frame, Parameter, Parameter, int, int) - Constructor for class org.orekit.forces.gravity.tides.AbstractTides
Build a new instance using Parameter.
AbstractTides(Frame, Parameter, Parameter, int, int, int, int) - Constructor for class org.orekit.forces.gravity.tides.AbstractTides
Build a new instance using Parameter.
AbstractTLEFitter - Class in org.orekit.propagation.analytical.tle
Abstract class for TLE/Orbit fitting.
AbstractTLEFitter(int, char, int, int, String, int, int) - Constructor for class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Simple constructor.
AbstractUnivariateDifferentiableSolver - Class in org.apache.commons.math3.analysis.solvers
Provide a default implementation for several functions useful to generic solvers.
AbstractUnivariateDifferentiableSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractUnivariateDifferentiableSolver
Construct a solver with given absolute accuracy.
AbstractUnivariateDifferentiableSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractUnivariateDifferentiableSolver
Construct a solver with given accuracies.
AbstractUnivariateSolver - Class in org.apache.commons.math3.analysis.solvers
Base class for solvers.
AbstractUnivariateSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractUnivariateSolver
Construct a solver with given absolute accuracy.
AbstractUnivariateSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractUnivariateSolver
Construct a solver with given accuracies.
AbstractUnivariateSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.AbstractUnivariateSolver
Construct a solver with given accuracies.
AbstractUnivariateStatistic - Class in org.apache.commons.math3.stat.descriptive
Abstract base class for all implementations of the UnivariateStatistic interface.
AbstractUnivariateStatistic() - Constructor for class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
 
AbstractVector3DFunction - Class in org.orekit.attitudes.kinematics
This abstract class is a time-dependent function representing a vector 3D.
AbstractVector3DFunction(AbsoluteDate) - Constructor for class org.orekit.attitudes.kinematics.AbstractVector3DFunction
Constructor setting a default finite differences differentiator and a default trapezoid integrator.
AbstractVector3DFunction(AbsoluteDate, UnivariateVectorFunctionDifferentiator) - Constructor for class org.orekit.attitudes.kinematics.AbstractVector3DFunction
Constructor setting a default trapezoid integrator.
AbstractVector3DFunction(AbsoluteDate, UnivariateVectorFunctionDifferentiator, UnivariateIntegrator) - Constructor for class org.orekit.attitudes.kinematics.AbstractVector3DFunction
Constructor.
AbstractWell - Class in org.apache.commons.math3.random
This abstract class implements the WELL class of pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
AbstractWell(int, int, int, int) - Constructor for class org.apache.commons.math3.random.AbstractWell
Creates a new random number generator.
AbstractWell(int, int, int, int, int) - Constructor for class org.apache.commons.math3.random.AbstractWell
Creates a new random number generator using a single int seed.
AbstractWell(int, int, int, int, int[]) - Constructor for class org.apache.commons.math3.random.AbstractWell
Creates a new random number generator using an int array seed.
AbstractWell(int, int, int, int, long) - Constructor for class org.apache.commons.math3.random.AbstractWell
Creates a new random number generator using a single long seed.
acceptStep(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Accept a step, triggering events and step handlers.
acceptStep(AbstractStepInterpolator, double[], double[], double) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Accept a step, triggering events and step handlers.
acceptStep(AbsoluteDate, double) - Method in class org.orekit.propagation.AbstractPropagator
Accept a step, triggering events and step handlers.
acos() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Arc cosine operation.
acos(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute arc cosine of a derivative structure.
Acos - Class in org.apache.commons.math3.analysis.function
Arc-cosine function.
Acos() - Constructor for class org.apache.commons.math3.analysis.function.Acos
 
acos() - Method in class org.apache.commons.math3.complex.Complex
Compute the inverse cosine of this complex number.
acos(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the arc-cosine of the argument.
acos() - Method in interface org.apache.commons.math3.RealFieldElement
Arc cosine operation.
acos(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the arc cosine of a number.
acosh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Inverse hyperbolic cosine operation.
acosh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute inverse hyperbolic cosine of a derivative structure.
Acosh - Class in org.apache.commons.math3.analysis.function
Hyperbolic arc-cosine function.
Acosh() - Constructor for class org.apache.commons.math3.analysis.function.Acosh
 
acosh() - Method in interface org.apache.commons.math3.RealFieldElement
Inverse hyperbolic cosine operation.
acosh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the inverse hyperbolic cosine of a number.
ACSOL_FILENAME - Static variable in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataFactory
Default file name for ACSOL
ACSOLFormatReader - Class in org.orekit.forces.atmospheres.solarActivity
This class reads ACSOL format solar activity data
ACSOLFormatReader(String) - Constructor for class org.orekit.forces.atmospheres.solarActivity.ACSOLFormatReader
Constructor.
AdamsBashforthIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements explicit Adams-Bashforth integrators for Ordinary Differential Equations.
AdamsBashforthIntegrator(int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsBashforthIntegrator
Build an Adams-Bashforth integrator with the given order and step control parameters.
AdamsBashforthIntegrator(int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsBashforthIntegrator
Build an Adams-Bashforth integrator with the given order and step control parameters.
AdamsIntegrator - Class in org.apache.commons.math3.ode.nonstiff
Base class for Adams-Bashforth and Adams-Moulton integrators.
AdamsIntegrator(String, int, int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Build an Adams integrator with the given order and step control parameters.
AdamsIntegrator(String, int, int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Build an Adams integrator with the given order and step control parameters.
AdamsMoultonIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements implicit Adams-Moulton integrators for Ordinary Differential Equations.
AdamsMoultonIntegrator(int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsMoultonIntegrator
Build an Adams-Moulton integrator with the given order and error control parameters.
AdamsMoultonIntegrator(int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdamsMoultonIntegrator
Build an Adams-Moulton integrator with the given order and error control parameters.
AdamsNordsieckTransformer - Class in org.apache.commons.math3.ode.nonstiff
Transformer to Nordsieck vectors for Adams integrators.
AdaptedEventDetector - Class in org.orekit.propagation.events
Adapt an EventDetector to commons-math EventHandler interface.
AdaptedEventDetector(EventDetector, Map<String, AdditionalStateInfo>, OrbitType, PositionAngle, AttitudeProvider, AttitudeProvider, AbsoluteDate, double, Frame) - Constructor for class org.orekit.propagation.events.AdaptedEventDetector
Build a wrapped event detector.
AdaptedMonoEventDetector - Class in fr.cnes.sirius.patrius.propagation.events.multi
This interface is copied from AdaptedEventDetector and adapted to multi propagation.
AdaptedMonoEventDetector(EventDetector, OrbitType, PositionAngle, AttitudeProvider, AttitudeProvider, AbsoluteDate, double, Frame, MultiStateVectorInfo, String) - Constructor for class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMonoEventDetector
Build a wrapped event detector.
AdaptedMultiEventDetector - Class in fr.cnes.sirius.patrius.propagation.events.multi
This interface is copied from AdaptedEventDetector and adapted to multi propagation.
AdaptedMultiEventDetector(MultiEventDetector, OrbitType, PositionAngle, Map<String, AttitudeProvider>, Map<String, AttitudeProvider>, AbsoluteDate, Map<String, Double>, Map<String, Frame>, MultiStateVectorInfo) - Constructor for class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMultiEventDetector
Build a wrapped multi-sat event detector.
AdaptedStepHandler - Class in org.orekit.propagation.sampling
Adapt an OrekitStepHandler to commons-math StepHandler interface.
AdaptedStepHandler(OrekitStepHandler) - Constructor for class org.orekit.propagation.sampling.AdaptedStepHandler
Build an instance.
AdapterPropagator - Class in org.orekit.propagation.analytical
Orbit propagator that adapts an underlying propagator, adding differential effects.
AdapterPropagator(Propagator) - Constructor for class org.orekit.propagation.analytical.AdapterPropagator
Build a propagator from an underlying reference propagator.
AdapterPropagator.DifferentialEffect - Interface in org.orekit.propagation.analytical
Interface for orbit differential effects.
AdaptiveStepsizeIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This abstract class holds the common part of all adaptive stepsize integrators for Ordinary Differential Equations.
AdaptiveStepsizeIntegrator(String, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Build an integrator with the given stepsize bounds.
AdaptiveStepsizeIntegrator(String, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Build an integrator with the given stepsize bounds.
add(CodedEvent) - Method in class fr.cnes.sirius.patrius.events.CodedEventsList
Add a CodedEvent to the list.
add(Phenomenon) - Method in class fr.cnes.sirius.patrius.events.PhenomenaList
Add a Phenomenon to the list.
add(ConstantThrustManeuver) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
Adds a continue maneuver (with constant thrust) to the list.
Always check first if the time interval of the maneuver respects the two following conditions: no superposition with any maneuver in the list; the time between the end of the previous maneuver and the start of the maneuver to add, as well as the time between the end of the maneuver to add and the start of the next maneuver, must be bigger than the threshold value.
add(VariableThrustManeuver) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
Adds a continue maneuver (with variable thrust) to the list.
Always check first if the time interval of the maneuver respects the two following conditions: no superposition with any maneuver in the list; the time between the end of the previous maneuver and the start of the maneuver to add, as well as the time between the end of the maneuver to add and the start of the next maneuver, must be bigger than the threshold value.
add(ImpulseManeuver) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
Adds an impulse maneuver to the list.
Two scenarios are possible: the maneuver to add is triggered by a detector other than DateDetector, always add the maneuver; the maneuver to add is triggered by a DateDetector, check if the date of the maneuver respects the two following conditions: no superposition with any maneuver in the list; the time between the end of the previous maneuver and the date of the maneuver to add, as well as the time between the end of the maneuver to add and the date of the next maneuver, must be bigger than the threshold value.
add(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'+' operator.
add(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'+' operator.
add(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform addition of two derivative structures.
Add - Class in org.apache.commons.math3.analysis.function
Add the two operands.
Add() - Constructor for class org.apache.commons.math3.analysis.function.Add
 
add(UnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Adds functions.
add(UnivariateDifferentiableFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Adds functions.
add(DifferentiableUnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated. as of 3.1 replaced by FunctionUtils.add(UnivariateDifferentiableFunction...)
add(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Add a polynomial to the instance.
add(TrigonometricPolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Add two TrigonometricPolynomialFunction
add(TrigonometricPolynomialPrimitive) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Add two TrigonometricPolynomialPrimitive
add(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Add a PolynomialFunction
add(TrigonometricPolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Add a TrigonometricPolynomialFunction
add(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this + addend).
add(double) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this + addend), with addend interpreted as a real number.
add(Quaternion, Quaternion) - Static method in class org.apache.commons.math3.complex.Quaternion
Computes the sum of two quaternions.
add(Quaternion) - Method in class org.apache.commons.math3.complex.Quaternion
Computes the sum of the instance and another quaternion.
add(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Add x to this.
add(T) - Method in interface org.apache.commons.math3.FieldElement
Compute this + a.
add(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
Adds the value of this fraction to the passed BigInteger, returning the result in reduced form.
add(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Adds the value of this fraction to the passed integer, returning the result in reduced form.
add(long) - Method in class org.apache.commons.math3.fraction.BigFraction
Adds the value of this fraction to the passed long, returning the result in reduced form.
add(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
Adds the value of this fraction to another, returning the result in reduced form.
add(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
Adds the value of this fraction to another, returning the result in reduced form.
add(int) - Method in class org.apache.commons.math3.fraction.Fraction
Add an integer to the fraction.
add(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Add a vector to the instance.
add(double, Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Add a scaled vector to the instance.
add(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a vector to the instance.
add(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a vector to the instance.
add(T, FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a scaled vector to the instance.
add(T, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a scaled vector to the instance.
add(double, FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a scaled vector to the instance.
add(double, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Add a scaled vector to the instance.
add(Matrix3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Computes the addition of two Matrix3D
add(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Add a vector to the instance.
add(double, Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Add a scaled vector to the instance.
add(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Add a vector to the instance.
add(double, Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Add a scaled vector to the instance.
add(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Add a vector to the instance.
add(double, Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Add a scaled vector to the instance.
add(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the sum of this and m.
add(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Add m to this matrix.
add(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Compute the sum of this and m.
add(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the sum of this and v.
add(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the sum of this and v.
add(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Compute the sum of this vector and v.
add(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Compute the sum of this and m.
add(BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the sum of this and m.
add(BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Compute the sum of this matrix and m.
add(DiagonalMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Compute the sum of this and m.
add(SymmetricMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Compute the sum of this and m.
add(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Compute the sum of this and m.
add(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Compute the sum of this and v.
add(OpenMapRealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Compute the sum of this matrix and m.
add(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Compute the sum of this vector and v.
add(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Optimized method to add two OpenMapRealVectors.
add(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the sum of this and m.
add(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Compute the sum of this vector and v.
add(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Optimized method to add sparse vectors.
add(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Compute the sum of this and v.
add(SymmetricMatrix) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Compute the sum of this and m.
add(DiagonalMatrix) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns the sum of this and m.
add(double) - Method in interface org.apache.commons.math3.RealFieldElement
'+' operator.
add(BigReal) - Method in class org.apache.commons.math3.util.BigReal
Compute this + a.
add(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute this + a.
add(String, AttitudeLeg) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Adds an AttitudeLeg instance to the sequence, with conditions.
The conditions are : A new instance can only be inserted at the beginning or the end of the sequence (except the first one of course).
add(OceanTidesCoefficientsSet) - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Add a OceanTidesCoefficientsSet to the data map
add(VariablePotentialCoefficientsSet) - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Add an entry
add(GeoMagneticField) - Method in class org.orekit.models.earth.GeoMagneticModelReader
Add a GeoMagneticField to the models list.
add(OrekitStepHandler) - Method in class org.orekit.propagation.sampling.OrekitStepHandlerMultiplexer
Add a step handler.
add(Wrench) - Method in class org.orekit.wrenches.Wrench
Sum of two wrenches.
addAcceleration(Vector3D, Frame) - Method in interface org.orekit.propagation.numerical.TimeDerivativesEquations
Add the contribution of an acceleration expressed in some inertial frame.
addAdditionalEquations(AdditionalEquations, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Add a set of user-specified equations to be integrated along with the orbit propagation.
addAdditionalEquations(StelaAdditionalEquations) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Add a set of user-specified additional equations to be integrated along with the orbit propagation.
addAdditionalEquations(AdditionalEquations) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Add a set of user-specified equations to be integrated along with the orbit propagation.
addAdditionalState(String, double[]) - Method in class org.orekit.propagation.SpacecraftState
Add an additional state to the additional states map.
addAdditionalStateDerivative(String, double[]) - Method in interface org.orekit.propagation.numerical.TimeDerivativesEquations
Add the contribution of the change rate (dX/dt) of the additional state.
addAdditionalStateProvider(AdditionalStateProvider) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Add a set of user-specified state parameters to be computed along with the orbit propagation.
addAdditionalStateProvider(AdditionalStateProvider) - Method in class org.orekit.propagation.AbstractPropagator
Add a set of user-specified state parameters to be computed along with the orbit propagation.
addAdditionalStateProvider(MassProvider) - Method in class org.orekit.propagation.AbstractPropagator
Add a set of state parameters from MassProvider to be computed along with the orbit propagation.
addAndCheck(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Add two integers, checking for overflow.
addAndCheck(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Add two long integers, checking for overflow.
addApKp(AbsoluteDate, Double[][]) - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Add a flux value
addAttitude(Attitude, AttitudeEquation.AttitudeType) - Method in class org.orekit.propagation.SpacecraftState
Add attitude to the additional states map.
addAttitudeEquation(AttitudeEquation, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Add a set of user-specified attitude equations to be integrated along with the orbit propagation.
addAttitudeEquation(StelaAttitudeAdditionalEquations) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Add a set of user-specified attitude equations to be integrated along with the orbit propagation.
addAttitudeEquation(AttitudeEquation) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Add a set of user-specified attitude equations to be integrated along with the orbit propagation.
addAttitudeToAdditionalStates(AttitudeEquation.AttitudeType) - Method in class org.orekit.propagation.SpacecraftState
Add attitude to the additional states map.
addCelestialBodyLoader(String, CelestialBodyLoader) - Static method in class org.orekit.bodies.CelestialBodyFactory
Add a loader for celestial bodies.
addChromosome(Chromosome) - Method in class org.apache.commons.math3.genetics.ListPopulation
Add the given chromosome to the population.
addChromosome(Chromosome) - Method in interface org.apache.commons.math3.genetics.Population
Add the given chromosome to the population.
addChromosomes(Collection<Chromosome>) - Method in class org.apache.commons.math3.genetics.ListPopulation
Add a Collection of chromosomes to this Population.
addCodedEvent(CodedEvent) - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
 
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
 
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
 
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.drag.DragForce
Compute the contribution of the drag to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in interface org.orekit.forces.ForceModel
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.gravity.BalminoAttractionModel
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.gravity.CunninghamAttractionModel
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.gravity.DrozinerAttractionModel
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.gravity.NewtonianAttraction
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.gravity.ThirdBodyAttraction
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.gravity.tides.AbstractTides
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.maneuvers.ConstantThrustError
Compute the contribution of the constant thrust error model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.radiation.RediffusedRadiationPressure
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.radiation.SolarRadiationPressure
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.relativistic.CoriolisRelativisticEffect
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.relativistic.LenseThirringRelativisticEffect
Compute the contribution of the force model to the perturbing acceleration.
addContribution(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.forces.relativistic.SchwarzschildRelativisticEffect
Compute the contribution of the force model to the perturbing acceleration.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
 
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.drag.DragForce
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.gravity.BalminoAttractionModel
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.gravity.CunninghamAttractionModel
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.gravity.NewtonianAttraction
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.gravity.ThirdBodyAttraction
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.gravity.tides.AbstractTides
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.maneuvers.ConstantThrustError
 
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.radiation.RediffusedRadiationPressure
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.radiation.SolarRadiationPressure
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.relativistic.CoriolisRelativisticEffect
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.relativistic.LenseThirringRelativisticEffect
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in class org.orekit.forces.relativistic.SchwarzschildRelativisticEffect
Compute acceleration derivatives with respect to additional parameters.
addDAccDParam(SpacecraftState, Parameter, double[]) - Method in interface org.orekit.parameter.IJacobiansParameterizable
Compute acceleration derivatives with respect to additional parameters.
addDAccDParamRediffusedRadiativePressure(SpacecraftState, Parameter, double[]) - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
 
addDAccDParamRediffusedRadiativePressure(SpacecraftState, Parameter, double[]) - Method in interface org.orekit.forces.radiation.RediffusedRadiationSensitive
Compute acceleration derivatives.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
 
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
 
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.drag.DragForce
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.gravity.BalminoAttractionModel
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.gravity.CunninghamAttractionModel
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.gravity.NewtonianAttraction
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.gravity.ThirdBodyAttraction
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.gravity.tides.AbstractTides
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
 
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.maneuvers.ConstantThrustError
 
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.radiation.RediffusedRadiationPressure
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.radiation.SolarRadiationPressure
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.relativistic.CoriolisRelativisticEffect
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.relativistic.LenseThirringRelativisticEffect
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in class org.orekit.forces.relativistic.SchwarzschildRelativisticEffect
Compute acceleration derivatives with respect to state parameters.
addDAccDState(SpacecraftState, double[][], double[][]) - Method in interface org.orekit.parameter.IJacobiansParameterizable
Compute acceleration derivatives with respect to state parameters.
addDAccDStateRediffusedRadiativePressure(SpacecraftState, double[][], double[][]) - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
 
addDAccDStateRediffusedRadiativePressure(SpacecraftState, double[][], double[][]) - Method in interface org.orekit.forces.radiation.RediffusedRadiationSensitive
Compute acceleration derivatives.
addData(double, double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Adds the observation (x,y) to the regression data set.
addData(double[][]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Adds the observations represented by the elements in data.
addDDragAccDParam(SpacecraftState, Parameter, double, Vector3D, double[]) - Method in class fr.cnes.sirius.patrius.assembly.models.AeroModel
Compute acceleration derivatives with respect to ballistic coefficient.
addDDragAccDParam(SpacecraftState, Parameter, double, Vector3D, double[]) - Method in class fr.cnes.sirius.patrius.assembly.models.DragLiftModel
Compute acceleration derivatives with respect to ballistic coefficient.
addDDragAccDParam(SpacecraftState, Parameter, double, Vector3D, double[]) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAeroModel
 
addDDragAccDParam(SpacecraftState, Parameter, double, Vector3D, double[]) - Method in interface org.orekit.forces.drag.DragSensitive
Compute acceleration derivatives with respect to additional parameters (the ballistic coefficient).
addDDragAccDState(SpacecraftState, double[][], double[][], double, Vector3D, Vector3D, boolean, boolean) - Method in class fr.cnes.sirius.patrius.assembly.models.AeroModel
Compute acceleration derivatives with respect to state parameters (position and velocity).
addDDragAccDState(SpacecraftState, double[][], double[][], double, Vector3D, Vector3D, boolean, boolean) - Method in class fr.cnes.sirius.patrius.assembly.models.DragLiftModel
Compute acceleration derivatives with respect to state parameters (position and velocity).
addDDragAccDState(SpacecraftState, double[][], double[][], double, Vector3D, Vector3D, boolean, boolean) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAeroModel
 
addDDragAccDState(SpacecraftState, double[][], double[][], double, Vector3D, Vector3D, boolean, boolean) - Method in interface org.orekit.forces.drag.DragSensitive
Compute acceleration derivatives with respect to state parameters (position and velocity).
addDefaultCelestialBodyLoader(String) - Static method in class org.orekit.bodies.CelestialBodyFactory
Add the default loaders for all predefined celestial bodies.
addDefaultCelestialBodyLoader(String, String) - Static method in class org.orekit.bodies.CelestialBodyFactory
Add the default loaders for celestial bodies.
addDefaultEOP1980HistoryLoaders(String, String, String, String) - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Add the default loaders for EOP 1980 history.
addDefaultEOP2000HistoryLoaders(String, String, String, String) - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Add the default loaders for EOP 2000 history.
addDefaultGeoMagneticModelReader(GeoMagneticFieldFactory.FieldModel) - Static method in class org.orekit.models.earth.GeoMagneticFieldFactory
Add a default reader for geomagnetic models.
addDefaultOceanTidesCoefficientsReaders() - Static method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsFactory
Add the default READERS for ocean tides coefficients
addDefaultPotentialCoefficientsReaders() - Static method in class org.orekit.forces.gravity.potential.GravityFieldFactory
Add the default READERS for gravity fields.
addDefaultProviders() - Method in class org.orekit.data.DataProvidersManager
Add the default providers configuration.
addDefaultSolarActivityDataReaders() - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataFactory
Add the default READERS for solar activity
addDefaultUTCTAILoader() - Static method in class org.orekit.time.TimeScalesFactory
Add the default loader for UTC-TAI offsets history files.
addDefaultVariablePotentialCoefficientsReaders() - Static method in class org.orekit.forces.gravity.variations.coefficients.VariableGravityFieldFactory
Add default readers
addDSRPAccDParam(SpacecraftState, Parameter, double[], Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
Compute acceleration derivatives with respect to additional parameters.
addDSRPAccDParam(SpacecraftState, Parameter, double[], Vector3D) - Method in interface org.orekit.forces.radiation.RadiationSensitive
Compute acceleration derivatives with respect to additional parameters.
addDSRPAccDState(SpacecraftState, double[][], double[][], Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
Compute acceleration derivatives with respect to state parameters.
addDSRPAccDState(SpacecraftState, double[][], double[][], Vector3D) - Method in interface org.orekit.forces.radiation.RadiationSensitive
Compute acceleration derivatives with respect to state parameters.
addEffect(AdapterPropagator.DifferentialEffect) - Method in class org.orekit.propagation.analytical.AdapterPropagator
Add a differential effect.
addElement(double) - Method in interface org.apache.commons.math3.util.DoubleArray
Adds an element to the end of this expandable array
addElement(double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Adds an element to the end of this expandable array.
addElementRolling(double) - Method in interface org.apache.commons.math3.util.DoubleArray
Adds an element to the end of the array and removes the first element in the array.
addElementRolling(double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Adds an element to the end of the array and removes the first element in the array.
addElements(double[]) - Method in interface org.apache.commons.math3.util.DoubleArray
Adds elements to the end of this expandable array
addElements(double[]) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Adds several element to the end of this expandable array.
addEntry(EOPEntry) - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Add an Earth Orientation Parameters entry.
addEOP1980HistoryLoader(EOP1980HistoryLoader) - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Add a loader for EOP 1980 history.
addEOP2000HistoryLoader(EOP2000HistoryLoader) - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Add a loader for EOP 2000 history.
addEventDate(AbsoluteDate) - Method in class org.orekit.propagation.events.DateDetector
Add an event date.
addEventDetector(MultiEventDetector) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Add a multi spacecraft event detector.
addEventDetector(EventDetector, String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Add an event detector to a specific spacecraft.
addEventDetector(MultiEventDetector) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
 
addEventDetector(EventDetector, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
 
addEventDetector(EventDetector) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Add an event detector.
addEventDetector(EventDetector) - Method in class org.orekit.propagation.AbstractPropagator
Add an event detector.
addEventDetector(EventDetector) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Add an event detector.
addEventDetector(EventDetector) - Method in interface org.orekit.propagation.Propagator
Add an event detector.
addEventHandler(EventHandler, double, double, int) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int, UnivariateSolver) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int, UnivariateSolver) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int, UnivariateSolver) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Add an event handler to the integrator.
addEventHandlers(boolean, Map<String, AttitudeProvider>, Map<String, AttitudeProvider>) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Add event handlers to integrator.
addF107(AbsoluteDate, double) - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Add a flux value
addFilter(String) - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
addFilter
addForceModel(ForceModel, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Add a force model to the global perturbation model of a specific spacecraft.
addForceModel(StelaForceModel) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Add a force model to the global perturbation model.
addForceModel(ForceModel) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Add a force model to the global perturbation model.
addGeoMagneticModelReader(GeoMagneticFieldFactory.FieldModel, GeoMagneticModelReader) - Static method in class org.orekit.models.earth.GeoMagneticFieldFactory
Add a reader for geomagnetic models.
addInitialAdditionalState(SpacecraftState) - Method in interface fr.cnes.sirius.patrius.stela.propagation.StelaAdditionalEquations
 
addInitialAdditionalState(SpacecraftState) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaPartialDerivativesEquations
 
addInitialState(SpacecraftState, String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Add a new spacecraft state to be propagated.
addInitialState(SpacecraftState, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
 
addIterationListener(IterationListener) - Method in class org.apache.commons.math3.util.IterationManager
Attaches a listener to this manager.
AdditionalEquations - Interface in org.orekit.propagation.numerical
This interface allows users to add their own differential equations to a numerical propagator.
AdditionalStateInfo - Class in org.orekit.propagation.numerical
Utility class that describes in a minimal fashion the structure of an additional state.
AdditionalStateInfo(int, int) - Constructor for class org.orekit.propagation.numerical.AdditionalStateInfo
Constructor.
AdditionalStateProvider - Interface in org.orekit.propagation
This interface represents providers for additional state data beyond SpacecraftState.
ADDITIVE_MODE - Static variable in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Please use ResizableDoubleArray.ExpansionMode.ADDITIVE instead.
addJacobiansParameter(Parameter) - Method in class org.orekit.parameter.JacobiansParameterizable
Add a new parameter in the jacobians parameters list.
addJacobiansParameter(ArrayList<Parameter>) - Method in class org.orekit.parameter.JacobiansParameterizable
Add a list of parameters in the jacobians parameters list.
addJacobiansParameter(Parameter...) - Method in class org.orekit.parameter.JacobiansParameterizable
Add a parameters in the jacobians parameters list.
addJQNUMRuleValue(String, double) - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
addJQNUMRuleValue
addJQNUMRuleValue(JQNUMTools.TypeStrategy, String, double) - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
addJQNUMRuleValue
addKeplerContribution(PositionAngle, double, double[]) - Method in class org.orekit.orbits.Orbit
Call the method Orbit.orbitAddKeplerContribution(PositionAngle, double, double[]) implemented in inherited classes of Orbit.
addKeplerContribution(double) - Method in interface org.orekit.propagation.numerical.TimeDerivativesEquations
Add the contribution of the Kepler evolution.
addLastPoint(AbsoluteDateInterval) - Method in class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
Decide if adding the last point of the time interval to the ephemeris list.
addLastPoint(AbsoluteDateInterval) - Method in class org.orekit.attitudes.FixedStepAttitudeEphemerisGenerator
 
addLastPoint(AbsoluteDateInterval) - Method in class org.orekit.attitudes.VariableStepAttitudeEphemerisGenerator
 
addMainPart(MainPart) - Method in class fr.cnes.sirius.patrius.assembly.Assembly
Adds the main part to the assembly.
addMainPart(String) - Method in class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
Adds the main part to the assembly : shall be done before adding any other part.
addMaskingCelestialBody(GeometricBodyShape) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Adds a celestial body shape to consider in maskings.
addMassDerivative(String, double) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
Add the mass derivate of the given part.
addMassDerivative(String, double) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
Add the mass derivate of the given part.
addMassDerivative(String, double) - Method in class fr.cnes.sirius.patrius.assembly.models.MassModel
Add the mass derivate of the given part.
addMassDerivative(double) - Method in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
Set the flow rate.
addMassDerivative(String, double) - Method in interface org.orekit.propagation.MassProvider
Add the mass derivate of the given part.
addMassDerivative(String, double) - Method in class org.orekit.propagation.SimpleMassModel
This model represents one part only.
addMassProvider(MassProvider) - Method in class org.orekit.propagation.SpacecraftState
Add the values of mass parts from MassProvider to additional states map.
addMassProviderEquation(MassProvider, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Add additional equations associated with the mass provider.
addMassProviderEquation(MassProvider) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Add additional equations associated with the mass provider.
addMessage(Localizable, Object...) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Adds a message.
addObservation(double[], double) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Adds an observation to the regression model.
addObservation(double[], double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Adds one observation to the regression model.
addObservation(double[], double) - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Adds one observation to the regression model.
addObservations(double[][], double[]) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Adds multiple observations to the model.
addObservations(double[][], double[]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Adds a series of observations to the regression model.
addObservations(double[][], double[]) - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Adds a series of observations to the regression model.
addObservedPoint(double, double) - Method in class org.apache.commons.math3.fitting.CurveFitter
Add an observed (x,y) point to the sample with unit weight.
addObservedPoint(double, double, double) - Method in class org.apache.commons.math3.fitting.CurveFitter
Add an observed weighted (x,y) point to the sample.
addObservedPoint(WeightedObservedPoint) - Method in class org.apache.commons.math3.fitting.CurveFitter
Add an observed weighted (x,y) point to the sample.
addObservedPoint(double, double) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated. Add an observed (x,y) point to the sample with unit weight.
addObservedPoint(double, double, double) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated. Add an observed weighted (x,y) point to the sample.
addObservedPoint(WeightedObservedPoint) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated. Add an observed weighted (x,y) point to the sample.
addOceanTidesCoefficientsReader(OceanTidesCoefficientsReader) - Static method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsFactory
Add a reader for ocean tides
addOffset(AngularCoordinates, boolean) - Method in class org.orekit.utils.AngularCoordinates
Add an offset from the instance.
addOffset(AngularCoordinates) - Method in class org.orekit.utils.AngularCoordinates
Add an offset from the instance.
addOffset(AngularCoordinates) - Method in class org.orekit.utils.TimeStampedAngularCoordinates
Add an offset from the instance.
addOffset(AngularCoordinates, boolean) - Method in class org.orekit.utils.TimeStampedAngularCoordinates
Add an offset from the instance.
addOwnMaskingParts(String[]) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Enables the masking by the considered spacecraft's own parts, by giving the names of the parts that can cause maskings.
addParameter(Parameter) - Method in class org.orekit.parameter.Parameterizable
Add a new parameter in the lit, only if it does not exist.
addParameterJacobianProvider(ParameterJacobianProvider) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Add a parameter Jacobian provider.
addPart(IPart) - Method in class fr.cnes.sirius.patrius.assembly.Assembly
Adds a part to the assembly.
addPart(String, String, Transform) - Method in class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
This method adds a new part to the currently built assembly, defining its new frame by a Transform object.
addPart(String, String, Vector3D, Rotation) - Method in class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
This method adds a new part to the currently built assembly.
addPhenomenon(Phenomenon) - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
 
addPoint(T) - Method in class org.apache.commons.math3.stat.clustering.Cluster
Add a point to this cluster.
addPoint(AbsoluteDate, double) - Method in class org.orekit.utils.SecularAndHarmonic
Add a fitting point.
addPotentialCoefficientsReader(PotentialCoefficientsReader) - Static method in class org.orekit.forces.gravity.potential.GravityFieldFactory
Add a reader for gravity fields.
addProperty(IPartProperty, String) - Method in class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
Adds a property of any type to a part of the assembly.
addProperty(IPartProperty) - Method in interface fr.cnes.sirius.patrius.assembly.IPart
Adds a property to the part.
addProperty(IPartProperty) - Method in class fr.cnes.sirius.patrius.assembly.MainPart
 
addProperty(IPartProperty) - Method in class fr.cnes.sirius.patrius.assembly.Part
 
addProvider(DataProvider) - Method in class org.orekit.data.DataProvidersManager
Add a data provider to the supported list.
addRule(Pair<T[], T[]>) - Method in class org.apache.commons.math3.analysis.integration.gauss.BaseRuleFactory
Stores a rule.
addSamplePoint(double, double[]...) - Method in class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Add a sample point.
addSamplePoint(double, double[]...) - Method in class org.orekit.utils.HermiteInterpolator
Add a sample point.
addSatellite(String) - Method in class org.orekit.files.sp3.SP3File
Add a new satellite with a given identifier to the list of stored satellites.
addSatelliteCoordinate(String, SatelliteTimeCoordinate) - Method in class org.orekit.files.sp3.SP3File
Adds a new P/V coordinate for a given satellite.
addSecondaryEquations(SecondaryEquations) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Add a set of secondary equations to be integrated along with the primary set.
addSecondaryMaskingSpacecraft(SecondarySpacecraft, String[]) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Enables the masking by a secondary spacecraft's parts, by giving the names of the parts that can cause maskings.
addSolarActivityDataReader(SolarActivityDataReader) - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataFactory
Add a reader for solar activity
addStepHandler(StepHandler) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Add a step handler to this integrator.
addStepHandler(StepHandler) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Add a step handler to this integrator.
addStepHandler(StepHandler) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Add a step handler to this integrator.
addSwitchingCondition(AttitudeLaw, EventDetector, boolean, boolean, AttitudeLaw) - Method in class org.orekit.attitudes.AttitudesSequence
Add a switching condition between two attitude providers.
addSystemFilter(String) - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
add a system filter to JQNUM
addTask(ParallelTaskFactory<?>, int) - Method in class fr.cnes.sirius.validate.parallel.ParallelRunner
Adds a new task factory, with the number of instances it should provide, OR updates the number of instances if the task factory was added before.
addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Change an entry at the specified index.
addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addToEntry(int, double) - Method in class org.apache.commons.math3.linear.RealVector
Change an entry at the specified index.
addToEntry(int, int, T) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Adds (in place) the specified value to the specified entry of this matrix.
addUTCTAILoader(UTCTAILoader) - Static method in class org.orekit.time.TimeScalesFactory
Add a loader for UTC-TAI offsets history files.
addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Adds the value to the dataset.
addValue(double[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Add an n-tuple to the data
addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Add a value to the data
addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Adds the value to the dataset.
addValue(double[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Add an n-tuple to the data
addValue(double) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Add a value to the data
addValue(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
Adds 1 to the frequency count for v.
addValue(int) - Method in class org.apache.commons.math3.stat.Frequency
Adds 1 to the frequency count for v.
addValue(long) - Method in class org.apache.commons.math3.stat.Frequency
Adds 1 to the frequency count for v.
addValue(char) - Method in class org.apache.commons.math3.stat.Frequency
Adds 1 to the frequency count for v.
addVariablePotentialCoefficientsReader(VariablePotentialCoefficientsReader) - Static method in class org.orekit.forces.gravity.variations.coefficients.VariableGravityFieldFactory
Add a specific reader
addXYZAcceleration(double, double, double) - Method in interface org.orekit.propagation.numerical.TimeDerivativesEquations
Add the contribution of an acceleration expressed in the inertial frame (it is important to make sure this acceleration is defined in the same frame as the orbit) .
advance(RealVector.Entry) - Method in class org.apache.commons.math3.linear.RealVector.SparseEntryIterator
Deprecated. Advance an entry up to the next nonzero one.
advance() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
Advance iterator one step further.
advance() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
Advance iterator one step further.
ae - Variable in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Central body reference radius.
AeroApplicationPoint - Class in fr.cnes.sirius.patrius.assembly.properties
This class represents a drag application point property
AeroApplicationPoint(Vector3D) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroApplicationPoint
Create a drag force application point property.
AeroFacetProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is a facet property to use with the aerodynamic part property for the PATRIUS assembly.
This property is meant to be used in a LEO average precision aerodynamic context.
AeroFacetProperty(Facet) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
Constructor of this property for default coefficient values.
AeroFacetProperty(Facet, double, double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
Constructor of this property.
AeroFacetProperty(Facet, Parameter, Parameter) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
Constructor of this property using Parameter.
AeroFacetProperty(Facet, IParamDiffFunction, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
Constructor of this property.
AeroGlobalProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is a aero global property to use with the aerodynamic part property for the PATRIUS assembly.
AeroGlobalProperty(double, double, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
This constructor shall be used for defining the surface as a ParamDiffFunction
AeroGlobalProperty(IParamDiffFunction, IParamDiffFunction, double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
This constructor shall be used for defining the aero coefficients as ParamDiffFunction
AeroModel - Class in fr.cnes.sirius.patrius.assembly.models
Class that represents an aero model, based on the vehicle.
AeroModel(Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.models.AeroModel
Aero model (the acceleration is computed from all the sub parts of the vehicle).
AeroSphereProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is a sphere property to use with the aerodynamic part property for the PATRIUS assembly.
This property is meant to be used in a LEO average precision aerodynamic context.
AeroSphereProperty(double, double, double, Vector3D) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Constructor of this property.
AeroSphereProperty(double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Constructor of this property with default value for C_X.
AeroSphereProperty(double, double, Vector3D) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Constructor of this property without the atmospheric height scale.
AeroSphereProperty(double, double, double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Constructor of this property giving the drag coef.
AeroSphereProperty(double, double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Constructor of this property giving the drag coef without the atmospheric height scale.
AeroSphereProperty(Parameter, double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Constructor of this property giving the drag coef without the atmospheric height scale.
AeroSphereProperty(double, double, Parameter) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
This constructor shall be used for defining the drag coef using Parameter
AeroSphereProperty(double, Parameter) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Constructor of this propertydefining the drag coef using Parameter without the atmospheric height scale.
AeroSphereProperty(double, double, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
This constructor shall be used for defining the drag coef as a ParamDiffFucntion
AeroSphereProperty(double, IParamDiffFunction) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Constructor of this property defining the drag coef as a ParamDiffFucntion without the atmospheric height scale.
AeroWrenchModel - Class in fr.cnes.sirius.patrius.assembly.models
This class represents a DragWrenchSensitive assembly model.
AeroWrenchModel(Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.models.AeroWrenchModel
Radiative model (the acceleration is computed from all the sub parts of the vehicle).
aggregate(Collection<SummaryStatistics>) - Static method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Computes aggregate summary statistics.
AggregateSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
An aggregator for SummaryStatistics from several data sets or data set partitions.
AggregateSummaryStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Initializes a new AggregateSummaryStatistics with default statistics implementations.
AggregateSummaryStatistics(SummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Initializes a new AggregateSummaryStatistics with the specified statistics object as a prototype for contributing statistics and for the internal aggregate statistics.
AggregateSummaryStatistics(SummaryStatistics, SummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Initializes a new AggregateSummaryStatistics with the specified statistics object as a prototype for contributing statistics and for the internal aggregate statistics.
align(int) - Method in class org.apache.commons.math3.dfp.Dfp
Make our exp equal to the supplied one, this may cause rounding.
AlignmentDetector - Class in org.orekit.propagation.events
Finder for satellite/body alignment events.
AlignmentDetector(Orbit, PVCoordinatesProvider, double) - Constructor for class org.orekit.propagation.events.AlignmentDetector
Build a new alignment detector.
AlignmentDetector(Orbit, PVCoordinatesProvider, double, double) - Constructor for class org.orekit.propagation.events.AlignmentDetector
Build a new alignment detector.
AlignmentDetector(Orbit, PVCoordinatesProvider, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.AlignmentDetector
Build a new alignment detector.
AlignmentDetector(Orbit, PVCoordinatesProvider, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.AlignmentDetector
Build a new alignment detector.
AllowedFileType - Enum in fr.cnes.sirius.patrius.tools.ephemerisComparator
This file lists the type of file that the ephemeris comparator can work with.
AllowedSolution - Enum in org.apache.commons.math3.analysis.solvers
The kinds of solutions that a (bracketed univariate real) root-finding algorithm may accept as solutions.
AlmanacParameter - Class in fr.cnes.sirius.patrius.utils
This class is a simple container for generic almanac parameters.
AlmanacParameter(double, int, double, double, double, double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.utils.AlmanacParameter
Creates an instance of AlmanacParameter
AlmanacPVCoordinates - Class in fr.cnes.sirius.patrius.utils
This class implements the PVCoordinatesProvider to compute position velocity of a GPS or Galileo constellation satellite from its almanac parameters.
AlmanacPVCoordinates(AlmanacParameter, int, double, double) - Constructor for class fr.cnes.sirius.patrius.utils.AlmanacPVCoordinates
Creates an instance of AlmanacPVCoordinates.
AltitudeDetector - Class in org.orekit.propagation.events
Finder for satellite altitude crossing events.
AltitudeDetector(double, BodyShape) - Constructor for class org.orekit.propagation.events.AltitudeDetector
Build a new altitude detector.
AltitudeDetector(double, BodyShape, double) - Constructor for class org.orekit.propagation.events.AltitudeDetector
Build a new altitude detector.
AltitudeDetector(double, BodyShape, double, double) - Constructor for class org.orekit.propagation.events.AltitudeDetector
Build a new altitude detector.
AltitudeDetector(double, BodyShape, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.AltitudeDetector
Build a new altitude detector.
AltitudeDetector(double, BodyShape, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.AltitudeDetector
Build a new altitude detector.
Analytical2DOrbitModel - Class in org.orekit.propagation.analytical.twod
This class represents an analytical 2D orbit model, it is made of 6 parameter models, one per adapted circular parameter.
Analytical2DOrbitModel(Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, int[], MassProvider, double) - Constructor for class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Create an analytical 2D orbit model with specified parameter models, development orders, standard gravitational parameter and spacecraft mass.
Analytical2DOrbitModel(Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, MassProvider, double) - Constructor for class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Create an analytical 2D orbit model with specified parameter models, standard gravitational parameter and spacecraft mass.
Analytical2DOrbitModel(Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, double) - Constructor for class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Create an analytical 2D orbit model with specified parameter models.
Analytical2DOrbitModel(Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, Analytical2DParameterModel, int[], double) - Constructor for class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Create an analytical 2D orbit model with specified parameter models.
Analytical2DParameterModel - Class in org.orekit.propagation.analytical.twod
This class represents an analytical 2D orbital parameter model.
Analytical2DParameterModel(UnivariateDateFunction, double[][]) - Constructor for class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Create a new analytical 2D orbital parameter model, with given polynomial and trigonometric developments.
Analytical2DPropagator - Class in org.orekit.propagation.analytical.twod
This class propagates an analytical 2D orbit model and extends the AbstractPropagator class.
Analytical2DPropagator(Analytical2DOrbitModel, AbsoluteDate) - Constructor for class org.orekit.propagation.analytical.twod.Analytical2DPropagator
Create an instance of a 2D propagator with default EME2000 aligned attitude.
Analytical2DPropagator(Analytical2DOrbitModel, AbsoluteDate, int[]) - Constructor for class org.orekit.propagation.analytical.twod.Analytical2DPropagator
Create an instance of a 2D propagator with default EME2000 aligned attitude.
Analytical2DPropagator(AttitudeProvider, Analytical2DOrbitModel, AbsoluteDate) - Constructor for class org.orekit.propagation.analytical.twod.Analytical2DPropagator
Create an instance of a 2D propagator.
Analytical2DPropagator(AttitudeProvider, Analytical2DOrbitModel, AbsoluteDate, int[]) - Constructor for class org.orekit.propagation.analytical.twod.Analytical2DPropagator
Create an instance of a 2D propagator.
AnalyticalEphemerisModeHandler - Class in org.orekit.propagation.analytical
This class stores sequentially generated orbital parameters for later retrieval.
AnalyticalEphemerisModeHandler(AbstractPropagator, AttitudeProvider, AttitudeProvider) - Constructor for class org.orekit.propagation.analytical.AnalyticalEphemerisModeHandler
Constructor.
AnalyticalIntegratedEphemeris - Class in org.orekit.propagation
This class stores sequentially generated orbital parameters for later retrieval.
AnalyticalIntegratedEphemeris(List<AbsoluteDate>, List<AbsoluteDate>, List<SpacecraftState>, AbstractPropagator, AttitudeProvider, AttitudeProvider, boolean) - Constructor for class org.orekit.propagation.AnalyticalIntegratedEphemeris
Constructor.
AndCriterion - Class in fr.cnes.sirius.patrius.events.postprocessing
 
AndCriterion(String, String, String, String) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.AndCriterion
Constructor
angle(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the angular separation between two vectors.
angle(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the angular separation between two vectors.
angle(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the angular separation between two vectors.
angle(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the angular separation between two vectors.
angleInInterval(double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Computes the angle in the given interval modulo 2pi.
AngleInterval - Class in fr.cnes.sirius.patrius.utils
- This class describes an angle interval.
AngleInterval(IntervalEndpointType, double, double, IntervalEndpointType) - Constructor for class fr.cnes.sirius.patrius.utils.AngleInterval
Constructor
Needs the two end points values.
AngleInterval(double, double, IntervalEndpointType, IntervalEndpointType) - Constructor for class fr.cnes.sirius.patrius.utils.AngleInterval
Constructor
Needs the reference angle and the interval length.
AngleTools - Class in fr.cnes.sirius.patrius.utils
This class provides static methods for angles :
AngularCoordinates - Class in org.orekit.utils
Simple container for rotation/rotation rate/rotation acceleration triplet.
AngularCoordinates() - Constructor for class org.orekit.utils.AngularCoordinates
Simple constructor.
AngularCoordinates(Rotation, Vector3D) - Constructor for class org.orekit.utils.AngularCoordinates
Builds a rotation/rotation rate triplet (acceleration set to Vector3D.ZERO).
AngularCoordinates(Rotation, Vector3D, Vector3D) - Constructor for class org.orekit.utils.AngularCoordinates
Builds a rotation/rotation rate/rotation acceleration triplet.
AngularCoordinates(PVCoordinates, PVCoordinates, PVCoordinates, PVCoordinates, double, boolean) - Constructor for class org.orekit.utils.AngularCoordinates
Build the rotation that transforms a pair of pv coordinates into another one.
AngularCoordinates(PVCoordinates, PVCoordinates, PVCoordinates, PVCoordinates, double) - Constructor for class org.orekit.utils.AngularCoordinates
Build the rotation that transforms a pair of pv coordinates into another one.
AngularCorrection - Interface in fr.cnes.sirius.patrius.signalpropagation
This interface is an angular correction model enabling the computation of the satellite elevation angular correction.
AngularDerivativesFilter - Enum in org.orekit.utils
Enumerate for selecting which derivatives to use in TimeStampedAngularCoordinates interpolation.
AngularVelocitiesHarmonicProfile - Class in fr.cnes.sirius.patrius.guidance
Represents an angular velocities guidance profile, calculated with Fourier series
AngularVelocitiesHarmonicProfile(AbsoluteDate, Rotation, Frame, FourierSeries, FourierSeries, FourierSeries, AbsoluteDateInterval, KinematicsToolkit.IntegrationType, double) - Constructor for class fr.cnes.sirius.patrius.guidance.AngularVelocitiesHarmonicProfile
Create a harmonic, angular velocities guidance profile.
AngularVelocitiesPolynomialProfile - Class in fr.cnes.sirius.patrius.guidance
Represents an angular velocities guidance profile, calculated with polynomial functions
AngularVelocitiesPolynomialProfile(Frame, AbsoluteDateInterval, Rotation, List<Vector3DPolynomialSegment>, KinematicsToolkit.IntegrationType, double) - Constructor for class fr.cnes.sirius.patrius.guidance.AngularVelocitiesPolynomialProfile
Create a polynomial, angular velocity guidance profile.
AnomalyDetector - Class in org.orekit.propagation.events
Detects when the anomaly of the spacecraft reaches a predetermined value, θ.
Anomaly is not defined for all kinds of orbits: this detector will detect anomaly events only if the corresponding orbit is not a circular orbit, otherwise it may trigger events randomly.
AnomalyDetector(PositionAngle, double) - Constructor for class org.orekit.propagation.events.AnomalyDetector
Constructor for an AnomalyDetector instance.
AnomalyDetector(PositionAngle, double, double, double) - Constructor for class org.orekit.propagation.events.AnomalyDetector
Constructor for an AnomalyDetector instance with complementary parameters.
AnomalyDetector(PositionAngle, double, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.AnomalyDetector
Constructor for an AnomalyDetector instance with complementary parameters.
AnomalyDetector(PositionAngle, double, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.AnomalyDetector
Constructor for an AnomalyDetector instance with complementary parameters.
anovaFValue(Collection<double[]>) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
Computes the ANOVA F-value for a collection of double[] arrays.
anovaPValue(Collection<double[]>) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
Computes the ANOVA P-value for a collection of double[] arrays.
anovaTest(Collection<double[]>, double) - Method in class org.apache.commons.math3.stat.inference.OneWayAnova
Performs an ANOVA test, evaluating the null hypothesis that there is no difference among the means of the data categories.
AnyMatrix - Interface in org.apache.commons.math3.linear
Interface defining very basic matrix operations.
AOLDetector - Class in org.orekit.propagation.events
Detects when the Argument of Latitude of the spacecraft reaches a predetermined value, θ.
AOLDetector(double, PositionAngle, Frame) - Constructor for class org.orekit.propagation.events.AOLDetector
Constructor for an AOLDetector instance.
AOLDetector(double, PositionAngle, Frame, double, double) - Constructor for class org.orekit.propagation.events.AOLDetector
Constructor for an AOLDetector instance with complementary parameters.
AOLDetector(double, PositionAngle, Frame, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.AOLDetector
Constructor for an AOLDetector instance with complementary parameters.
AOLDetector(double, PositionAngle, Frame, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.AOLDetector
Constructor for an AOLDetector instance with complementary parameters.
ApCoef - Class in org.orekit.forces.atmospheres.MSIS2000
/** Class Ap_coef Array containing the following magnetic values: 0 : daily AP 1 : 3 hr AP index for current time 2 : 3 hr AP index for 3 hrs before current time 3 : 3 hr AP index for 6 hrs before current time 4 : 3 hr AP index for 9 hrs before current time 5 : Average of eight 3 hr AP indicies from 12 to 33 hrs prior to current time 6 : Average of eight 3 hr AP indicies from 36 to 57 hrs prior to current time
ApCoef() - Constructor for class org.orekit.forces.atmospheres.MSIS2000.ApCoef
Constructor.
ApCoef(double[]) - Constructor for class org.orekit.forces.atmospheres.MSIS2000.ApCoef
Constructor.
APOGEE - Static variable in class org.orekit.propagation.events.ApsideDetector
Flag for apogee detection (slopeSelection = 1).
ApparentElevationDetector - Class in org.orekit.propagation.events
Finder for satellite apparent elevation events.
ApparentElevationDetector(double, TopocentricFrame) - Constructor for class org.orekit.propagation.events.ApparentElevationDetector
Build a new apparent elevation detector.
ApparentElevationDetector(double, TopocentricFrame, double) - Constructor for class org.orekit.propagation.events.ApparentElevationDetector
Build a new apparent elevation detector.
ApparentElevationDetector(double, TopocentricFrame, double, double) - Constructor for class org.orekit.propagation.events.ApparentElevationDetector
Build a new apparent elevation detector.
ApparentElevationDetector(double, TopocentricFrame, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ApparentElevationDetector
Build a new apparent elevation detector with specified actions at raising and setting.
ApparentElevationDetector(double, TopocentricFrame, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.ApparentElevationDetector
Build a new apparent elevation detector with specified actions at raising and setting.
append(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending a vector to this vector.
append(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending a vector to this vector.
append(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending a T to this vector.
append(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Construct a new vector by appending a vector to this vector.
append(ArrayRealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending a vector to this vector.
append(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Construct a new vector by appending a double to this vector.
append(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Construct a vector by appending a vector to this vector.
append(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Construct a vector by appending a T to this vector.
append(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Optimized method to append a OpenMapRealVector.
append(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Construct a new vector by appending a vector to this vector.
append(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Construct a new vector by appending a double to this vector.
append(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Construct a new vector by appending a vector to this vector.
append(double) - Method in class org.apache.commons.math3.linear.RealVector
Construct a new vector by appending a double to this vector.
append(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Construct a vector by appending a vector to this vector.
append(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Construct a vector by appending a vector to this vector.
append(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Construct a vector by appending a T to this vector.
append(ContinuousOutputModel) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Append another model at the end of the instance.
apply(Vector<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Transform
Transform a point of a space.
apply(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Transform
Transform an hyperplane of a space.
apply(SubHyperplane<T>, Hyperplane<S>, Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Transform
Transform a sub-hyperplane embedded in an hyperplane.
apply(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Apply the given statistic to the data associated with this set of statistics.
apply(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Apply the given statistic to the data associated with this set of statistics.
apply(Orbit) - Method in class org.orekit.forces.maneuvers.SmallManeuverAnalyticalModel
Compute the effect of the maneuver on an orbit.
apply(SpacecraftState) - Method in class org.orekit.forces.maneuvers.SmallManeuverAnalyticalModel
Compute the effect of the maneuver on a spacecraft state.
apply(SpacecraftState) - Method in interface org.orekit.propagation.analytical.AdapterPropagator.DifferentialEffect
Apply the effect to a spacecraft state.
apply(Orbit) - Method in class org.orekit.propagation.analytical.J2DifferentialEffect
Compute the effect of the maneuver on an orbit.
apply(SpacecraftState) - Method in class org.orekit.propagation.analytical.J2DifferentialEffect
Apply the effect to a spacecraft state.
applyInverseTo(List<Vector2D>) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Inverse Projects a list of Vector2D (projected points) with a given projection.
applyInverseTo(double[], double[]) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Inversion transformation of arrays of x and y projected coordinates.
applyInverseTo(double, double, double) - Method in class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
This is the Two standard parallel Mercator Projection model.
applyInverseTo(double, double) - Method in class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
Inverse projection.
applyInverseTo(double, double) - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
Inverse projection.
applyInverseTo(double, double, double) - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
This is the Two standard parallel Mercator Projection model.
applyInverseTo(double, double) - Method in interface fr.cnes.sirius.patrius.projections.IProjection
Inverse projection.
applyInverseTo(double, double, double) - Method in interface fr.cnes.sirius.patrius.projections.IProjection
This is the Two standard parallel Mercator Projection model.
applyInverseTo(double, double, double) - Method in class fr.cnes.sirius.patrius.projections.Mercator
This is the Two standard parallel Mercator Projection model.
applyInverseTo(double, double) - Method in class fr.cnes.sirius.patrius.projections.Mercator
Inverse projection.
applyInverseTo(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the rotation to a vector.
applyInverseTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the rotation to a vector.
applyInverseTo(T[], T[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the rotation to a vector stored in an array.
applyInverseTo(double[], T[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the rotation to a vector stored in an array.
applyInverseTo(Rotation, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of a rotation to a vector.
applyInverseTo(FieldRotation<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the instance to another rotation.
applyInverseTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the instance to another rotation.
applyInverseTo(Rotation, FieldRotation<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the inverse of the a rotation to another rotation.
applyInverseTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the inverse of the rotation to a vector.
applyInverseTo(double[], double[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the inverse of the rotation to a vector stored in an array.
applyInverseTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the inverse of the instance to another rotation.
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.AndCriterion
Adds to the phenomena list of a TimeLine object the phenomena corresponding to each time intervals when phenomena of particular types A and B occur at the same time.
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.DelayCriterion
 
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.ElementTypeFilter
 
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.EventsDuringPhenomenaFilter
 
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.MergePhenomenaCriterion
 
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.MergeTimelines
 
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.OccurrenceFilter
 
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.OrCriterion
Adds to the phenomena list of a TimeLine object the phenomena corresponding to each time intervals when phenomena of particular types A OR B occur.
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.PhenomenonDurationFilter
Removes from the list the specified phenomena that are longer / shorter than the duration criterion (depending on the isMinDuration boolean value).
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.PolarizationSingleSelection
 
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.PolarizationSwitch
 
applyTo(Timeline) - Method in interface fr.cnes.sirius.patrius.events.postprocessing.PostProcessing
 
applyTo(Timeline) - Method in class fr.cnes.sirius.patrius.events.postprocessing.TimeFilter
 
applyTo(NumericalPropagator) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
Adds all the maneuvers (continue and impulse) to the propagator.
applyTo(List<GeodeticPoint>) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Project a list of GeodeticPoints with a given projection.
applyTo(double, double) - Method in class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
Returns Easting value and Northing value in meters from latitude and longitude coordinates.
applyTo(GeodeticPoint) - Method in class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
Returns Easting value and Northing value in meters from geodetic coordinates.
applyTo(GeodeticPoint) - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
Returns Easting value and Northing value in meters from geodetic coordinates.
applyTo(double, double) - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
Returns Easting value and Northing value in meters from latitude and longitude coordinates.
applyTo(GeodeticPoint) - Method in interface fr.cnes.sirius.patrius.projections.IProjection
Returns Easting value and Northing value in meters from geodetic coordinates.
applyTo(double, double) - Method in interface fr.cnes.sirius.patrius.projections.IProjection
Returns Easting value and Northing value in meters from latitude and longitude coordinates.
applyTo(GeodeticPoint) - Method in class fr.cnes.sirius.patrius.projections.Mercator
Returns Easting value and Northing value in meters from geodetic coordinates.
applyTo(double, double) - Method in class fr.cnes.sirius.patrius.projections.Mercator
Returns Easting value and Northing value in meters from latitude and longitude coordinates.
applyTo(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the rotation to a vector.
applyTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the rotation to a vector.
applyTo(T[], T[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the rotation to a vector stored in an array.
applyTo(double[], T[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the rotation to a vector stored in an array.
applyTo(Rotation, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply a rotation to a vector.
applyTo(FieldRotation<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the instance to another rotation.
applyTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply the instance to another rotation.
applyTo(Rotation, FieldRotation<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Apply a rotation to another rotation.
applyTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the rotation to a vector.
applyTo(double[], double[]) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the rotation to a vector stored in an array.
applyTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Apply the instance to another rotation.
applyTo(PVCoordinates) - Method in class org.orekit.utils.AngularCoordinates
Apply the rotation to a pv coordinates.
applyTo(TimeStampedPVCoordinates) - Method in class org.orekit.utils.AngularCoordinates
Apply the rotation to a pv coordinates.
applyToAndDiscretize(GeodeticPoint, GeodeticPoint, double, boolean) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Project two points, then discretize 2D the line.
applyTransform(Transform<S, T>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Transform a region.
applyTransform(Transform<S, T>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Apply a transform to the instance.
approximateAsPolynomialOnly(int, AbsoluteDate, int, int, AbsoluteDate, AbsoluteDate, double) - Method in class org.orekit.utils.SecularAndHarmonic
Approximate an already fitted model to polynomial only terms.
ApsideDetector - Class in org.orekit.propagation.events
Finder for apside crossing events.
ApsideDetector(Orbit, int) - Constructor for class org.orekit.propagation.events.ApsideDetector
Build a new instance.
ApsideDetector(Orbit, int, double) - Constructor for class org.orekit.propagation.events.ApsideDetector
Build a new instance.
ApsideDetector(int, double, double) - Constructor for class org.orekit.propagation.events.ApsideDetector
Build a new instance.
ApsideDetector(double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ApsideDetector
Build a new instance with both apogee and perigee detection.
ApsideDetector(double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.ApsideDetector
Build a new instance with both apogee and perigee detection.
ApsideDetector(int, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ApsideDetector
Build a new instance with apogee OR/AND perigee detection depending on slope selection.
ApsideDetector(int, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.ApsideDetector
Build a new instance with apogee OR/AND perigee detection depending on slope selection.
ApsisAltitudeParameters - Class in org.orekit.orbits.orbitalparameters
This class handles periapsis altitude/apoapsis altitude parameters.
ApsisAltitudeParameters(double, double, double, double, double, double, PositionAngle, double, double) - Constructor for class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Creates a new instance.
ApsisOrbit - Class in org.orekit.orbits
This class handles periapsis/apoapsis parameters.
ApsisOrbit(IOrbitalParameters, Frame, AbsoluteDate) - Constructor for class org.orekit.orbits.ApsisOrbit
Creates a new instance.
ApsisOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.ApsisOrbit
Creates a new instance.
ApsisOrbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.ApsisOrbit
Constructor from cartesian parameters.
ApsisOrbit(Orbit) - Constructor for class org.orekit.orbits.ApsisOrbit
Constructor from any kind of orbital parameters.
ApsisRadiusParameters - Class in org.orekit.orbits.orbitalparameters
This class handles periapsis/apoapsis parameters.
ApsisRadiusParameters(double, double, double, double, double, double, PositionAngle, double) - Constructor for class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Creates a new instance.
apToKp(double) - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityToolbox
Convert a single ap coefficient to a kp coefficient
apToKp(double[]) - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityToolbox
Convert an array
ARC_SECONDS_TO_RADIANS - Static variable in interface org.orekit.utils.Constants
Conversion factor from arc seconds to radians: 2*PI/(360*60*60).
areAddStatesSupported - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
True if the spacecraft states contains additional states.
areAttitudesSupported - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
True if the spacecraft states contains one or two attitudes.
argument(BodiesElements) - Method in class org.orekit.data.SeriesTerm
Compute the argument for the current date.
ArgUtils - Class in org.apache.commons.math3.exception.util
Utility class for transforming the list of arguments passed to constructors of exceptions.
ArithmeticUtils - Class in org.apache.commons.math3.util
Some useful, arithmetics related, additions to the built-in functions in Math.
Array2DRowFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Implementation of FieldMatrix using a FieldElement[][] array to store entries.
Array2DRowFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Creates a matrix with no data
Array2DRowFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> with the supplied row and column dimensions.
Array2DRowFieldMatrix(T[][]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> using the input array as the underlying data array.
Array2DRowFieldMatrix(Field<T>, T[][]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> using the input array as the underlying data array.
Array2DRowFieldMatrix(T[][], boolean) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> using the input array as the underlying data array.
Array2DRowFieldMatrix(Field<T>, T[][], boolean) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new FieldMatrix<T> using the input array as the underlying data array.
Array2DRowFieldMatrix(T[]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new (column) FieldMatrix<T> using v as the data for the unique column of the created matrix.
Array2DRowFieldMatrix(Field<T>, T[]) - Constructor for class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Create a new (column) FieldMatrix<T> using v as the data for the unique column of the created matrix.
Array2DRowRealMatrix - Class in org.apache.commons.math3.linear
Implementation of RealMatrix using a double[][] array to store entries.
Array2DRowRealMatrix() - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Creates a matrix with no data
Array2DRowRealMatrix(int, int) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new RealMatrix with the supplied row and column dimensions.
Array2DRowRealMatrix(double[][]) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new RealMatrix using the input array as the underlying data array.
Array2DRowRealMatrix(double[][], boolean) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new RealMatrix using the input array as the underlying data array.
Array2DRowRealMatrix(double[]) - Constructor for class org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new (column) RealMatrix using v as the data for the unique column of the created matrix.
ArrayFieldVector<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
This class implements the FieldVector interface with a FieldElement array.
ArrayFieldVector(Field<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Build a 0-length vector.
ArrayFieldVector(Field<T>, int) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector of zeroes.
ArrayFieldVector(int, T) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector with preset values.
ArrayFieldVector(T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from an array, copying the input array.
ArrayFieldVector(Field<T>, T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from an array, copying the input array.
ArrayFieldVector(T[], boolean) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Create a new ArrayFieldVector using the input array as the underlying data array.
ArrayFieldVector(Field<T>, T[], boolean) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Create a new ArrayFieldVector using the input array as the underlying data array.
ArrayFieldVector(T[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from part of a array.
ArrayFieldVector(Field<T>, T[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from part of a array.
ArrayFieldVector(FieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from another vector, using a deep copy.
ArrayFieldVector(ArrayFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from another vector, using a deep copy.
ArrayFieldVector(ArrayFieldVector<T>, boolean) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector from another vector.
ArrayFieldVector(ArrayFieldVector<T>, ArrayFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(ArrayFieldVector<T>, T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(T[], ArrayFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(T[], T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(Field<T>, T[], T[]) - Constructor for class org.apache.commons.math3.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayRealVector - Class in org.apache.commons.math3.linear
This class implements the RealVector interface with a double array.
ArrayRealVector() - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Build a 0-length vector.
ArrayRealVector(int) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector of zeroes.
ArrayRealVector(int, double) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector with preset values.
ArrayRealVector(double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from an array, copying the input array.
ArrayRealVector(double[], boolean) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Create a new ArrayRealVector using the input array as the underlying data array.
ArrayRealVector(double[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from part of a array.
ArrayRealVector(Double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from an array.
ArrayRealVector(Double[], int, int) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from part of an array.
ArrayRealVector(RealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from another vector, using a deep copy.
ArrayRealVector(ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from another vector, using a deep copy.
ArrayRealVector(ArrayRealVector, boolean) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector from another vector.
ArrayRealVector(ArrayRealVector, ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(ArrayRealVector, RealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(RealVector, ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(ArrayRealVector, double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(double[], ArrayRealVector) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(double[], double[]) - Constructor for class org.apache.commons.math3.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ASCENDING - Static variable in class org.orekit.propagation.events.NodeDetector
Flag for ascending node detection (slopeSelection = 0).
ASCENDING_DESCENDING - Static variable in class org.orekit.propagation.events.NodeDetector
Flag for both ascending and descending node detection (slopeSelection = 2).
asin() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Arc sine operation.
asin(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute arc sine of a derivative structure.
Asin - Class in org.apache.commons.math3.analysis.function
Arc-sine function.
Asin() - Constructor for class org.apache.commons.math3.analysis.function.Asin
 
asin() - Method in class org.apache.commons.math3.complex.Complex
Compute the inverse sine of this complex number.
asin(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the arc-sine of the argument.
asin() - Method in interface org.apache.commons.math3.RealFieldElement
Arc sine operation.
asin(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the arc sine of a number.
asinh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Inverse hyperbolic sine operation.
asinh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute inverse hyperbolic sine of a derivative structure.
Asinh - Class in org.apache.commons.math3.analysis.function
Hyperbolic arc-sine function.
Asinh() - Constructor for class org.apache.commons.math3.analysis.function.Asinh
 
asinh() - Method in interface org.apache.commons.math3.RealFieldElement
Inverse hyperbolic sine operation.
asinh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the inverse hyperbolic sine of a number.
asList() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an ordered list of intervals representing the instance.
Assembly - Class in fr.cnes.sirius.patrius.assembly
This class describes an assembly by all its sub parts.
Assembly() - Constructor for class fr.cnes.sirius.patrius.assembly.Assembly
Assembly simple constructor.
AssemblyBuilder - Class in fr.cnes.sirius.patrius.assembly
- This class is the builder that shall be needed to create an instance of the assembly.
AssemblyBuilder() - Constructor for class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
Simple constructor of an assembly builder.
AssemblyBuilder(Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
Constructor with an assembly instance.
assertEquals(double, double, double, double, double, String) - Method in class fr.cnes.sirius.validate.validationTool.Validate
Works as a replacement to the Assert.assertEquals(double, double, double) method.
assertEqualsArray(double[], double[], double, double[], double, String) - Method in class fr.cnes.sirius.validate.validationTool.Validate
Compute the deviation of each table value and store it to be put in the logs by the produceLogs method.
assertEqualsArrayWithRelativeTolerance(double[], double[], double, double[], double, String) - Method in class fr.cnes.sirius.validate.validationTool.Validate
Compute the deviation of each table value and store it to be put in the logs by the produceLogs method, but with a relative tolerance.
assertEqualsWithRelativeTolerance(double, double, double, double, double, String) - Method in class fr.cnes.sirius.validate.validationTool.Validate
Works as a replacement to the Assert.assertEquals(double, double, double) method for a relative comparison.
atan() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Arc tangent operation.
atan(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute arc tangent of a derivative structure.
Atan - Class in org.apache.commons.math3.analysis.function
Arc-tangent function.
Atan() - Constructor for class org.apache.commons.math3.analysis.function.Atan
 
atan() - Method in class org.apache.commons.math3.complex.Complex
Compute the inverse tangent of this complex number.
atan(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the arc tangent of the argument Uses the typical taylor series but may reduce arguments using the following identity tan(x+y) = (tan(x) + tan(y)) / (1 - tan(x)*tan(y)) since tan(PI/8) = sqrt(2)-1, atan(x) = atan( (x - sqrt(2) + 1) / (1+x*sqrt(2) - x) + PI/8.0
atan() - Method in interface org.apache.commons.math3.RealFieldElement
Arc tangent operation.
atan(double) - Static method in class org.apache.commons.math3.util.FastMath
Arctangent function
atan2(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Two arguments arc tangent operation.
atan2(DerivativeStructure, DerivativeStructure) - Static method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Two arguments arc tangent operation.
atan2(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute two arguments arc tangent of a derivative structure.
Atan2 - Class in org.apache.commons.math3.analysis.function
Arc-tangent function.
Atan2() - Constructor for class org.apache.commons.math3.analysis.function.Atan2
 
atan2(T) - Method in interface org.apache.commons.math3.RealFieldElement
Two arguments arc tangent operation.
atan2(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Two arguments arctangent function
atanh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Inverse hyperbolic tangent operation.
atanh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute inverse hyperbolic tangent of a derivative structure.
Atanh - Class in org.apache.commons.math3.analysis.function
Hyperbolic arc-tangent function.
Atanh() - Constructor for class org.apache.commons.math3.analysis.function.Atanh
 
atanh() - Method in interface org.apache.commons.math3.RealFieldElement
Inverse hyperbolic tangent operation.
atanh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the inverse hyperbolic tangent of a number.
atanInternal(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the arc-tangent of the argument.
Atmosphere - Interface in org.orekit.forces.atmospheres
Interface for atmospheric models.
ATOMIC_NITROGEN - Static variable in class org.orekit.forces.atmospheres.DTM2000
Identifier for atomic nitrogen.
ATOMIC_OXYGEN - Static variable in class org.orekit.forces.atmospheres.DTM2000
Identifier for atomic oxygen.
Attitude - Class in org.orekit.attitudes
This class handles attitude definition at a given date.
Attitude(Frame, TimeStampedAngularCoordinates) - Constructor for class org.orekit.attitudes.Attitude
Creates a new instance.
Attitude(AbsoluteDate, Frame, AngularCoordinates) - Constructor for class org.orekit.attitudes.Attitude
Creates a new instance.
Attitude(AbsoluteDate, Frame, Rotation, Vector3D, Vector3D) - Constructor for class org.orekit.attitudes.Attitude
Creates a new instance.
Attitude(AbsoluteDate, Frame, Rotation, Vector3D) - Constructor for class org.orekit.attitudes.Attitude
Creates a new instance.
Attitude(double[], AbsoluteDate, Frame) - Constructor for class org.orekit.attitudes.Attitude
Creates a new instance from an array containing a quaternion and a spin vector.
AttitudeChronologicalComparator - Class in org.orekit.attitudes
This class is a comparator used to compare the Attitude objects in the ephemeris set.
AttitudeChronologicalComparator() - Constructor for class org.orekit.attitudes.AttitudeChronologicalComparator
Simple constructor.
AttitudeEquation - Class in org.orekit.propagation.numerical
This interface allows users to add their own attitude differential equations to a numerical propagator.
AttitudeEquation(AttitudeEquation.AttitudeType) - Constructor for class org.orekit.propagation.numerical.AttitudeEquation
Create a new attitude equation.
AttitudeEquation.AttitudeType - Enum in org.orekit.propagation.numerical
 
AttitudeFrame - Class in org.orekit.attitudes
This class is a special implementation of the Frame class; it represents a dynamic spacecraft frame, i.e.
AttitudeFrame(PVCoordinatesProvider, AttitudeLaw, Frame) - Constructor for class org.orekit.attitudes.AttitudeFrame
Constructor of the dynamic spacecraft frame.
AttitudeLaw - Interface in org.orekit.attitudes
This interface has been created to represent a generic attitude provider without an interval of validity: the attitude can be computed at any date.
AttitudeLawLeg - Class in org.orekit.attitudes
This class represents an attitude law version "attitude", with an interval of validity (whose borders are closed points).
AttitudeLawLeg(AttitudeLaw, AbsoluteDate, AbsoluteDate) - Constructor for class org.orekit.attitudes.AttitudeLawLeg
Build an attitude law version "attitude".
AttitudeLawModifier - Interface in org.orekit.attitudes
This interface represents an attitude law that modifies/wraps another underlying law.
AttitudeLeg - Interface in org.orekit.attitudes
Interface which makes it obligatory to give an interval of validity to an attitude law.
All the classes implementing this interface should have an interval of validity with CLOSED endpoints.
AttitudeLegLaw - Class in org.orekit.attitudes
This class represents an attitude law version "attitudeLeg", with an interval of validity (whose borders are closed points) and attitude laws outside this interval of validity.
AttitudeLegLaw(AttitudeLaw, AttitudeLeg, AttitudeLaw) - Constructor for class org.orekit.attitudes.AttitudeLegLaw
Build an attitude law version "attitudeLeg".
AttitudeLegsSequence - Class in org.orekit.attitudes
This class handles a sequence of different attitude providers AttitudeLeg.
AttitudeLegsSequence(PVCoordinatesProvider) - Constructor for class org.orekit.attitudes.AttitudeLegsSequence
Only constructor for this class.
AttitudeProvider - Interface in org.orekit.attitudes
This interface represents an attitude provider model set.
attitudeProviderByDefault - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Attitude provider given by default for one attitude.
attitudeProviderEvents - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Attitude provider for events computation.
attitudeProviderForces - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Attitude provider for forces computation.
attitudesInterpolation(SpacecraftState[], int, int, AbsoluteDate) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
This method is called only if attitudes are supported.
AttitudesSequence - Class in org.orekit.attitudes
This classes manages a sequence of different attitude providers that are activated in turn according to switching events.
AttitudesSequence() - Constructor for class org.orekit.attitudes.AttitudesSequence
Constructor for an initially empty sequence.
AttitudeTransformProvider - Class in org.orekit.attitudes
This class is a TransformProvider for AttitudeFrame; it provides, for a given date, the transformation corresponding to the spacecraft reference frame orientation with respect to the parent frame.
AttitudeTransformProvider(AttitudeLaw, PVCoordinatesProvider, Frame) - Constructor for class org.orekit.attitudes.AttitudeTransformProvider
Protected constructor.
AttractionModel - Interface in org.orekit.forces.gravity
This interface represents a gravitation attraction model.
AVLTree<T extends Comparable<T>> - Class in org.apache.commons.math3.geometry.partitioning.utilities
This class implements AVL trees.
AVLTree() - Constructor for class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Build an empty tree.
AVLTree.Node - Class in org.apache.commons.math3.geometry.partitioning.utilities
This class implements AVL trees nodes.
AX_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.forces.EmpiricalForce
X-component of the A coefficient.
AY_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.forces.EmpiricalForce
Y-component of the A coefficient.
AZ_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.forces.EmpiricalForce
Z-component of the A coefficient.
AzimuthElevationField - Class in fr.cnes.sirius.patrius.fieldsofview
Field of view defined by an azimuth-elevation mask : the algorithms are from the Orekit GroundMaskElevationDetector detector.
AzimuthElevationField(double[][], double, String) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.AzimuthElevationField
Constructor for the azimuth - elevation mask
AzoulayModel - Class in fr.cnes.sirius.patrius.signalpropagation
This class is a tropospheric correction model that implements the TroposphericCorrection and AngularCorrection interfaces to correct a signal with the Azoulay model.
AzoulayModel(double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.AzoulayModel
 
AzoulayModel(double, double, double, double, boolean) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.AzoulayModel
 

B

B - Static variable in class org.orekit.parameter.LinearFunction
Default ordinate origin name.
BalminoAttractionModel - Class in org.orekit.forces.gravity
Computation of central body attraction with normalized coefficients and Helmholtz Polynomials.
BalminoAttractionModel(Frame, double, double, double[][], double[][]) - Constructor for class org.orekit.forces.gravity.BalminoAttractionModel
Create an instance of a normalized gravity computation model using normalized coefficients.
BalminoAttractionModel(Frame, double, double, double[][], double[][], int, int) - Constructor for class org.orekit.forces.gravity.BalminoAttractionModel
Create an instance of a normalized gravity computation model using normalized coefficients.
BalminoAttractionModel(Frame, Parameter, Parameter, double[][], double[][]) - Constructor for class org.orekit.forces.gravity.BalminoAttractionModel
Create an instance of a normalized gravity computation model using normalized coefficients.
BalminoAttractionModel(Frame, Parameter, Parameter, double[][], double[][], int, int) - Constructor for class org.orekit.forces.gravity.BalminoAttractionModel
Create an instance of a normalized gravity computation model using normalized coefficients.
BaseAbstractMultivariateOptimizer<FUNC extends MultivariateFunction> - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
BaseAbstractMultivariateOptimizer() - Constructor for class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. See SimpleValueChecker.SimpleValueChecker()
BaseAbstractMultivariateOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.  
BaseAbstractMultivariateSimpleBoundsOptimizer<FUNC extends MultivariateFunction> - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
BaseAbstractMultivariateSimpleBoundsOptimizer() - Constructor for class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
Deprecated. See SimpleValueChecker.SimpleValueChecker()
BaseAbstractMultivariateSimpleBoundsOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
Deprecated.  
BaseAbstractMultivariateVectorOptimizer<FUNC extends MultivariateVectorFunction> - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
BaseAbstractMultivariateVectorOptimizer() - Constructor for class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. See SimpleVectorValueChecker.SimpleVectorValueChecker()
BaseAbstractMultivariateVectorOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated.  
BaseAbstractUnivariateIntegrator - Class in org.apache.commons.math3.analysis.integration
Provide a default implementation for several generic functions.
BaseAbstractUnivariateIntegrator(double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Construct an integrator with given accuracies and iteration counts.
BaseAbstractUnivariateIntegrator(double, double) - Constructor for class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Construct an integrator with given accuracies.
BaseAbstractUnivariateIntegrator(int, int) - Constructor for class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Construct an integrator with given iteration counts.
BaseAbstractUnivariateOptimizer - Class in org.apache.commons.math3.optimization.univariate
Deprecated. As of 3.1 (to be removed in 4.0).
BaseAbstractUnivariateOptimizer(ConvergenceChecker<UnivariatePointValuePair>) - Constructor for class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.  
BaseAbstractUnivariateSolver<FUNC extends UnivariateFunction> - Class in org.apache.commons.math3.analysis.solvers
Provide a default implementation for several functions useful to generic solvers.
BaseAbstractUnivariateSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Construct a solver with given absolute accuracy.
BaseAbstractUnivariateSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Construct a solver with given accuracies.
BaseAbstractUnivariateSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Construct a solver with given accuracies.
BaseMultiStartMultivariateOptimizer<PAIR> - Class in org.apache.commons.math3.optim
Base class multi-start optimizer for a multivariate function.
BaseMultiStartMultivariateOptimizer(BaseMultivariateOptimizer<PAIR>, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Create a multi-start optimizer from a single-start optimizer.
BaseMultivariateMultiStartOptimizer<FUNC extends MultivariateFunction> - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
BaseMultivariateMultiStartOptimizer(BaseMultivariateOptimizer<FUNC>, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated. Create a multi-start optimizer from a single-start optimizer.
BaseMultivariateOptimizer<PAIR> - Class in org.apache.commons.math3.optim
Base class for implementing optimizers for multivariate functions.
BaseMultivariateOptimizer(ConvergenceChecker<PAIR>) - Constructor for class org.apache.commons.math3.optim.BaseMultivariateOptimizer
 
BaseMultivariateOptimizer<FUNC extends MultivariateFunction> - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
BaseMultivariateSimpleBoundsOptimizer<FUNC extends MultivariateFunction> - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
BaseMultivariateVectorMultiStartOptimizer<FUNC extends MultivariateVectorFunction> - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
BaseMultivariateVectorMultiStartOptimizer(BaseMultivariateVectorOptimizer<FUNC>, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated. Create a multi-start optimizer from a single-start optimizer.
BaseMultivariateVectorOptimizer<FUNC extends MultivariateVectorFunction> - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
BaseOptimizer<PAIR> - Class in org.apache.commons.math3.optim
Base class for implementing optimizers.
BaseOptimizer(ConvergenceChecker<PAIR>) - Constructor for class org.apache.commons.math3.optim.BaseOptimizer
 
BaseOptimizer<PAIR> - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
BaseRuleFactory<T extends Number> - Class in org.apache.commons.math3.analysis.integration.gauss
Base class for rules that determines the integration nodes and their weights.
BaseRuleFactory() - Constructor for class org.apache.commons.math3.analysis.integration.gauss.BaseRuleFactory
 
BaseSecantSolver - Class in org.apache.commons.math3.analysis.solvers
Base class for all bracketing Secant-based methods for root-finding (approximating a zero of a univariate real function).
BaseSecantSolver(double, BaseSecantSolver.Method) - Constructor for class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Construct a solver.
BaseSecantSolver(double, double, BaseSecantSolver.Method) - Constructor for class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Construct a solver.
BaseSecantSolver(double, double, double, BaseSecantSolver.Method) - Constructor for class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Construct a solver.
BaseSecantSolver.Method - Enum in org.apache.commons.math3.analysis.solvers
Secant-based root-finding methods.
BaseUnivariateOptimizer<FUNC extends UnivariateFunction> - Interface in org.apache.commons.math3.optimization.univariate
Deprecated. As of 3.1 (to be removed in 4.0).
BaseUnivariateSolver<FUNC extends UnivariateFunction> - Interface in org.apache.commons.math3.analysis.solvers
Interface for (univariate real) rootfinding algorithms.
BasicBoardSun - Class in fr.cnes.sirius.patrius.bodies
This class provides the Sun direction at a specific date, according to a simple analytical model.
BasicBoardSun() - Constructor for class fr.cnes.sirius.patrius.bodies.BasicBoardSun
Constructor with default values.
BasicBoardSun(AbsoluteDate, double, double, double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.bodies.BasicBoardSun
Constructor with user values.
basicPropagate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
Propagate an orbit without any fancy features.
basicPropagate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Propagate a SpacecraftState without any fancy features.
basicPropagate(AbsoluteDate) - Method in class org.orekit.propagation.AbstractPropagator
Propagate an orbit without any fancy features.
basicPropagate(AbsoluteDate) - Method in class org.orekit.propagation.analytical.AdapterPropagator
Propagate an orbit without any fancy features.
basicPropagate(AbsoluteDate) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
 
basicPropagate(AbsoluteDate) - Method in class org.orekit.propagation.precomputed.Ephemeris
 
basicPropagate(AbsoluteDate) - Method in class org.orekit.propagation.precomputed.IntegratedEphemeris
Propagate an orbit without any fancy features.
BasicPVCoordinatesProvider - Class in fr.cnes.sirius.patrius.tools.force.validation
 
BasicPVCoordinatesProvider(PVCoordinates, Frame) - Constructor for class fr.cnes.sirius.patrius.tools.force.validation.BasicPVCoordinatesProvider
Build a direction from an origin and a target described by their PVCoordinatesProvider
BasicStepInterpolator - Class in org.orekit.propagation.sampling
Implementation of the OrekitStepInterpolator interface based on a Propagator.
BasicStepInterpolator(Propagator) - Constructor for class org.orekit.propagation.sampling.BasicStepInterpolator
Build a new instance from a basic propagator.
BentModel - Class in fr.cnes.sirius.patrius.signalpropagation.iono
Bent model for the electronic content used in ionospheric corrections.
BentModel(R12Provider, SolarActivityDataProvider, USKProvider, BodyShape, Vector3D, Frame, double) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.iono.BentModel
Constructor for the Bent ionospheric correction model.
Beta - Class in org.apache.commons.math3.special
This is a utility class that provides computation methods related to the Beta family of functions.
beta0 - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
sqrt (1 - e2).
beta02 - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
1 - e2.
BetaAngleDetector - Class in org.orekit.propagation.events
Detects when the beta angle of the spacecraft reaches a predetermined value.
The beta angle is the angle between the orbit plane and the vector from the central body to the sun.
BetaAngleDetector(double) - Constructor for class org.orekit.propagation.events.BetaAngleDetector
Constructor for a BetaAngleDetector instance.
BetaAngleDetector(double, double, double) - Constructor for class org.orekit.propagation.events.BetaAngleDetector
Constructor for a BetaAngleDetector instance with complimentary parameters.
BetaAngleDetector(double, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.BetaAngleDetector
Constructor for a BetaAngleDetector instance with complimentary parameters.
BetaAngleDetector(double, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.BetaAngleDetector
Constructor for a BetaAngleDetector instance with complimentary parameters.
BetaDistribution - Class in org.apache.commons.math3.distribution
Implements the Beta distribution.
BetaDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.BetaDistribution
Build a new instance.
BetaDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.BetaDistribution
Build a new instance.
BetaDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.BetaDistribution
Creates a β distribution.
BicubicSplineInterpolatingFunction - Class in org.apache.commons.math3.analysis.interpolation
Function that implements the bicubic spline interpolation.
BicubicSplineInterpolatingFunction(double[], double[], double[][], double[][], double[][], double[][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
 
BicubicSplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Generates a bicubic interpolating function.
BicubicSplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolator
 
bigDecimalValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a BigDecimal.
bigDecimalValue(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a BigDecimal following the passed rounding mode.
bigDecimalValue(int, int) - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a BigDecimal following the passed scale and rounding mode.
bigDecimalValue() - Method in class org.apache.commons.math3.util.BigReal
Get the BigDecimal value corresponding to the instance.
BigFraction - Class in org.apache.commons.math3.fraction
Representation of a rational number without any overflow.
BigFraction(BigInteger) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction equivalent to the passed BigInteger, ie "num / 1".
BigFraction(BigInteger, BigInteger) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction given the numerator and denominator as BigInteger.
BigFraction(double) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a fraction given the double value.
BigFraction(double, double, int) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a fraction given the double value and maximum error allowed.
BigFraction(double, int) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a fraction given the double value and maximum denominator.
BigFraction(int) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction equivalent to the passed int, ie "num / 1".
BigFraction(int, int) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction given the numerator and denominator as simple int.
BigFraction(long) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction equivalent to the passed long, ie "num / 1".
BigFraction(long, long) - Constructor for class org.apache.commons.math3.fraction.BigFraction
Create a BigFraction given the numerator and denominator as simple long.
BigFractionField - Class in org.apache.commons.math3.fraction
Representation of the fractional numbers without any overflow field.
BigFractionFormat - Class in org.apache.commons.math3.fraction
Formats a BigFraction number in proper format or improper format.
BigFractionFormat() - Constructor for class org.apache.commons.math3.fraction.BigFractionFormat
Create an improper formatting instance with the default number format for the numerator and denominator.
BigFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.BigFractionFormat
Create an improper formatting instance with a custom number format for both the numerator and denominator.
BigFractionFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.BigFractionFormat
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
bigFractionMatrixToRealMatrix(FieldMatrix<BigFraction>) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Convert a FieldMatrix/BigFraction matrix to a RealMatrix.
BigReal - Class in org.apache.commons.math3.util
Arbitrary precision decimal number.
BigReal(BigDecimal) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a BigDecimal.
BigReal(BigInteger) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a BigInteger.
BigReal(BigInteger, int) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from an unscaled BigInteger.
BigReal(BigInteger, int, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from an unscaled BigInteger.
BigReal(BigInteger, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a BigInteger.
BigReal(char[]) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a characters representation.
BigReal(char[], int, int) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a characters representation.
BigReal(char[], int, int, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a characters representation.
BigReal(char[], MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a characters representation.
BigReal(double) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a double.
BigReal(double, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a double.
BigReal(int) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from an int.
BigReal(int, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from an int.
BigReal(long) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a long.
BigReal(long, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a long.
BigReal(String) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a String representation.
BigReal(String, MathContext) - Constructor for class org.apache.commons.math3.util.BigReal
Build an instance from a String representation.
BigRealField - Class in org.apache.commons.math3.util
Representation of real numbers with arbitrary precision field.
BiLinearIntervalsFunction - Class in org.apache.commons.math3.analysis.interpolation
Implements the representation of a linear function in dimension 2.
BiLinearIntervalsFunction(double[], double[], double[][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.BiLinearIntervalsFunction
Constructor, in two dimensions.
BiLinearIntervalsFunction(ISearchIndex, ISearchIndex, double[][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.BiLinearIntervalsFunction
Constructor, in two dimensions with a search index algorithm as a parameter.
BiLinearIntervalsInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Class representing a BivariateGridInterpolator for linear interpolation in dimension 2.
BiLinearIntervalsInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.BiLinearIntervalsInterpolator
 
BinaryChromosome - Class in org.apache.commons.math3.genetics
Chromosome represented by a vector of 0s and 1s.
BinaryChromosome(List<Integer>) - Constructor for class org.apache.commons.math3.genetics.BinaryChromosome
Constructor.
BinaryChromosome(Integer[]) - Constructor for class org.apache.commons.math3.genetics.BinaryChromosome
Constructor.
BinaryMutation - Class in org.apache.commons.math3.genetics
Mutation for BinaryChromosomes.
BinaryMutation() - Constructor for class org.apache.commons.math3.genetics.BinaryMutation
 
binarySearchClosedOpen(double[], double, int, int) - Static method in class org.apache.commons.math3.utils.SearchIndexLibrary
Searches the index corresponding to the parameter key inside [tab[iMin], tab[iMax]] with the default convention CLOSED_OPEN, meaning that interval considered are [ tab[i], tab[i+1] [ and therefore, if x = tab[i], the integer returned is i.
BinarySearchIndexClosedOpen - Class in org.apache.commons.math3.utils
Searches index in a double[] with a coupled dichotomy-BinarySearch algorithms.
BinarySearchIndexClosedOpen(double[]) - Constructor for class org.apache.commons.math3.utils.BinarySearchIndexClosedOpen
Constructor.
BinarySearchIndexOpenClosed - Class in org.apache.commons.math3.utils
Searches index in a double[] with a coupled dichotomy-BinarySearch algorithms.
BinarySearchIndexOpenClosed(double[]) - Constructor for class org.apache.commons.math3.utils.BinarySearchIndexOpenClosed
Constructor.
binarySearchOpenClosed(double[], double, int, int) - Static method in class org.apache.commons.math3.utils.SearchIndexLibrary
Searches the index corresponding to the parameter key inside [tab[iMin], tab[iMax]] with the convention OPEN_CLOSED, meaning that interval considered are ] tab[i], tab[i+1] ] and therefore, if x = tab[i], the integer returned is i-1.
binomialCoefficient(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns an exact representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficient(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns an exact representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientDouble(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns a double representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientDouble(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns a double representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientGeneric(int, int) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Compute the Binomial Coefficient, "a choose b", the number of b-element subsets that can be selected from an a-element set.
binomialCoefficientLog(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns the natural log of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientLog(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns the natural log of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
BinomialDistribution - Class in org.apache.commons.math3.distribution
Implementation of the binomial distribution.
BinomialDistribution(int, double) - Constructor for class org.apache.commons.math3.distribution.BinomialDistribution
Create a binomial distribution with the given number of trials and probability of success.
BinomialDistribution(RandomGenerator, int, double) - Constructor for class org.apache.commons.math3.distribution.BinomialDistribution
Creates a binomial distribution.
BisectionSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the bisection algorithm for finding zeros of univariate real functions.
BisectionSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.BisectionSolver
Construct a solver with default accuracy (1e-6).
BisectionSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.BisectionSolver
Construct a solver.
BisectionSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.BisectionSolver
Construct a solver.
BitsStreamGenerator - Class in org.apache.commons.math3.random
Base class for random number generators that generates bits streams.
BitsStreamGenerator() - Constructor for class org.apache.commons.math3.random.BitsStreamGenerator
Creates a new random number generator.
BivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a bivariate real function.
BivariateGridInterpolator - Interface in org.apache.commons.math3.analysis.interpolation
Interface representing a bivariate real interpolating function where the sample points must be specified on a regular grid.
BLOCK_SIZE - Static variable in class org.apache.commons.math3.linear.BlockFieldMatrix
Block size.
BLOCK_SIZE - Static variable in class org.apache.commons.math3.linear.BlockRealMatrix
Block size.
BlockFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Cache-friendly implementation of FieldMatrix using a flat arrays to store square blocks of the matrix.
BlockFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.BlockFieldMatrix
Create a new matrix with the supplied row and column dimensions.
BlockFieldMatrix(T[][]) - Constructor for class org.apache.commons.math3.linear.BlockFieldMatrix
Create a new dense matrix copying entries from raw layout data.
BlockFieldMatrix(int, int, T[][], boolean) - Constructor for class org.apache.commons.math3.linear.BlockFieldMatrix
Create a new dense matrix copying entries from block layout data.
blockInverse(RealMatrix, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Computes the inverse of the given matrix by splitting it into 4 sub-matrices.
BlockRealMatrix - Class in org.apache.commons.math3.linear
Cache-friendly implementation of RealMatrix using a flat arrays to store square blocks of the matrix.
BlockRealMatrix(int, int) - Constructor for class org.apache.commons.math3.linear.BlockRealMatrix
Create a new matrix with the supplied row and column dimensions.
BlockRealMatrix(double[][]) - Constructor for class org.apache.commons.math3.linear.BlockRealMatrix
Create a new dense matrix copying entries from raw layout data.
BlockRealMatrix(int, int, double[][], boolean) - Constructor for class org.apache.commons.math3.linear.BlockRealMatrix
Create a new dense matrix copying entries from block layout data.
BOBYQAOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
Powell's BOBYQA algorithm.
BOBYQAOptimizer(int) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
 
BOBYQAOptimizer(int, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
 
BOBYQAOptimizer - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
BOBYQAOptimizer(int) - Constructor for class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated.  
BOBYQAOptimizer(int, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated.  
BodiesElements - Class in org.orekit.data
Elements of the bodies having an effect on nutation.
BodiesElements(double, double, double, double, double, double, double, double, double, double, double, double, double, double) - Constructor for class org.orekit.data.BodiesElements
Simple constructor.
BodyCenterGroundPointing - Class in org.orekit.attitudes
This class handles body center pointing attitude provider; the difference between BodyCenterPointing and this class is that the target point of the former is the body center, while that of the latter is the corresponding point on the ground.
BodyCenterGroundPointing(BodyShape) - Constructor for class org.orekit.attitudes.BodyCenterGroundPointing
Constructor.
BodyCenterPointing - Class in org.orekit.attitudes
This class handles body center pointing attitude provider.
BodyCenterPointing(Frame) - Constructor for class org.orekit.attitudes.BodyCenterPointing
Creates new instance.
BodyCenterPointing() - Constructor for class org.orekit.attitudes.BodyCenterPointing
Creates new instance.
bodyFrame - Variable in class org.orekit.forces.gravity.tides.AbstractTides
Frame for the central body.
BodyShape - Interface in org.orekit.bodies
Interface representing the rigid surface shape of a natural body.
bool(double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Flags
Return boolean from double.
BooleanField - Class in fr.cnes.sirius.patrius.fieldsofview
This class describes a boolean field of view that combines two existing fields with a "AND" or "OR" boolean combination.
BooleanField(String, IFieldOfView, IFieldOfView, BooleanField.BooleanCombination) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.BooleanField
Constructor for the "AND" or "OR" combined field of view
BooleanField.BooleanCombination - Enum in fr.cnes.sirius.patrius.fieldsofview
The boolean combination to be applied
BoundaryAttribute<S extends Space> - Class in org.apache.commons.math3.geometry.partitioning
Class holding boundary attributes.
BoundaryAttribute(SubHyperplane<S>, SubHyperplane<S>) - Constructor for class org.apache.commons.math3.geometry.partitioning.BoundaryAttribute
Simple constructor.
BoundedPropagator - Interface in org.orekit.propagation
This interface is intended for ephemerides valid only during a time range.
boundedToUnbounded(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
Maps an array from bounded to unbounded.
boundedToUnbounded(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter
Deprecated. Map an array from bounded to unbounded.
bracket(UnivariateFunction, double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
This method attempts to find two values a and b satisfying lowerBound <= a < initial < b <= upperBound f(a) * f(b) < 0 If f is continuous on [a,b], this means that a and b bracket a root of f.
bracket(UnivariateFunction, double, double, double, int) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
This method attempts to find two values a and b satisfying lowerBound <= a < initial < b <= upperBound f(a) * f(b) <= 0 If f is continuous on [a,b], this means that a and b bracket a root of f.
BracketedUnivariateSolver<FUNC extends UnivariateFunction> - Interface in org.apache.commons.math3.analysis.solvers
Interface for (univariate real) root-finding algorithms that maintain a bracketed solution.
BracketFinder - Class in org.apache.commons.math3.optim.univariate
Provide an interval that brackets a local optimum of a function.
BracketFinder() - Constructor for class org.apache.commons.math3.optim.univariate.BracketFinder
Constructor with default values 100, 50 (see the other constructor).
BracketFinder(double, int) - Constructor for class org.apache.commons.math3.optim.univariate.BracketFinder
Create a bracketing interval finder.
BracketFinder - Class in org.apache.commons.math3.optimization.univariate
Deprecated. As of 3.1 (to be removed in 4.0).
BracketFinder() - Constructor for class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated. Constructor with default values 100, 50 (see the other constructor).
BracketFinder(double, int) - Constructor for class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated. Create a bracketing interval finder.
BracketingNthOrderBrentSolver - Class in org.apache.commons.math3.analysis.solvers
This class implements a modification of the Brent algorithm.
BracketingNthOrderBrentSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Construct a solver with default accuracy and maximal order (1e-6 and 5 respectively)
BracketingNthOrderBrentSolver(double, int) - Constructor for class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Construct a solver.
BracketingNthOrderBrentSolver(double, double, int) - Constructor for class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Construct a solver.
BracketingNthOrderBrentSolver(double, double, double, int) - Constructor for class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Construct a solver.
BracketingNthOrderBrentSolverDFP - Class in org.apache.commons.math3.dfp
This class implements a modification of the Brent algorithm.
BracketingNthOrderBrentSolverDFP(Dfp, Dfp, Dfp, int) - Constructor for class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Construct a solver.
BrentOptimizer - Class in org.apache.commons.math3.optim.univariate
For a function defined on some interval (lo, hi), this class finds an approximation x to the point at which the function attains its minimum.
BrentOptimizer(double, double, ConvergenceChecker<UnivariatePointValuePair>) - Constructor for class org.apache.commons.math3.optim.univariate.BrentOptimizer
The arguments are used implement the original stopping criterion of Brent's algorithm.
BrentOptimizer(double, double) - Constructor for class org.apache.commons.math3.optim.univariate.BrentOptimizer
The arguments are used for implementing the original stopping criterion of Brent's algorithm.
BrentOptimizer - Class in org.apache.commons.math3.optimization.univariate
Deprecated. As of 3.1 (to be removed in 4.0).
BrentOptimizer(double, double, ConvergenceChecker<UnivariatePointValuePair>) - Constructor for class org.apache.commons.math3.optimization.univariate.BrentOptimizer
Deprecated. The arguments are used implement the original stopping criterion of Brent's algorithm.
BrentOptimizer(double, double) - Constructor for class org.apache.commons.math3.optimization.univariate.BrentOptimizer
Deprecated. The arguments are used for implementing the original stopping criterion of Brent's algorithm.
BrentSolver - Class in org.apache.commons.math3.analysis.solvers
This class implements the Brent algorithm for finding zeros of real univariate functions.
BrentSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.BrentSolver
Construct a solver with default accuracy (1e-6).
BrentSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.BrentSolver
Construct a solver.
BrentSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.BrentSolver
Construct a solver.
BrentSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.BrentSolver
Construct a solver.
BSPTree<S extends Space> - Class in org.apache.commons.math3.geometry.partitioning
This class represent a Binary Space Partition tree.
BSPTree() - Constructor for class org.apache.commons.math3.geometry.partitioning.BSPTree
Build a tree having only one root cell representing the whole space.
BSPTree(Object) - Constructor for class org.apache.commons.math3.geometry.partitioning.BSPTree
Build a tree having only one root cell representing the whole space.
BSPTree(SubHyperplane<S>, BSPTree<S>, BSPTree<S>, Object) - Constructor for class org.apache.commons.math3.geometry.partitioning.BSPTree
Build a BSPTree from its underlying elements.
BSPTree.LeafMerger<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface gather the merging operations between a BSP tree leaf and another BSP tree.
BSPTreeVisitor<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface is used to visit BSP tree nodes.
BSPTreeVisitor.Order - Enum in org.apache.commons.math3.geometry.partitioning
Enumerate for visit order with respect to plus sub-tree, minus sub-tree and cut sub-hyperplane.
build(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Build an initial simplex.
build(double[]) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Build an initial simplex.
buildArray(Field<T>, int, int) - Static method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Build an array of elements.
buildArray(Field<T>, int) - Static method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Build an array of elements.
buildArray(Field<T>, int) - Static method in class org.apache.commons.math3.util.MathArrays
Build an array of elements.
buildArray(Field<T>, int, int) - Static method in class org.apache.commons.math3.util.MathArrays
Build a double dimension array of elements.
buildCodedEvent(SpacecraftState, boolean) - Method in interface fr.cnes.sirius.patrius.events.CodingEventDetector
Build a CodedEvent instance appropriate for the provided SpacecraftState.
buildCodedEvent(SpacecraftState, boolean) - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
buildCodedEvent(Map<String, SpacecraftState>, boolean) - Method in interface fr.cnes.sirius.patrius.events.multi.MultiCodingEventDetector
Build a CodedEvent instance appropriate for the provided map of SpacecraftState.
buildCodedEvent(Map<String, SpacecraftState>, boolean) - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
buildCodedEventListMap() - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger
Builds a map of CodedEventsList, one list per CodingEventDetector instance.
buildCodedEventListMap() - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger
Builds a map of CodedEventsList, one list per MultiCodingEventDetector instance.
buildConvex(Hyperplane<S>...) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Build a convex region from a collection of bounding hyperplanes.
buildDateDPFacade(double[]) - Static method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.DateDPFacade
factory method.
buildDelayedCodedEvent(SpacecraftState, boolean) - Method in interface fr.cnes.sirius.patrius.events.CodingEventDetector
Build a delayed CodedEvent instance appropriate for the provided SpacecraftState.
buildDelayedCodedEvent(SpacecraftState, boolean) - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
buildDelayedCodedEvent(Map<String, SpacecraftState>, boolean) - Method in interface fr.cnes.sirius.patrius.events.multi.MultiCodingEventDetector
Build a delayed CodedEvent instance appropriate for the provided map of SpacecraftState.
buildDelayedCodedEvent(Map<String, SpacecraftState>, boolean) - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
buildNew(BSPTree<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build a region using the instance as a prototype.
buildNew(Hyperplane<Euclidean1D>, Region<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
Build a sub-hyperplane from an hyperplane and a region.
buildNew(BSPTree<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a region using the instance as a prototype.
buildNew(Hyperplane<Euclidean3D>, Region<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubPlane
Build a sub-hyperplane from an hyperplane and a region.
buildNew(BSPTree<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a region using the instance as a prototype.
buildNew(Hyperplane<Euclidean2D>, Region<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Build a sub-hyperplane from an hyperplane and a region.
buildNew(BSPTree<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Build a region using the instance as a prototype.
buildNew(Hyperplane<S>, Region<T>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Build a sub-hyperplane from an hyperplane and a region.
buildNew(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Build a region using the instance as a prototype.
buildOccurrenceCodedEvent(SpacecraftState, boolean) - Method in interface fr.cnes.sirius.patrius.events.CodingEventDetector
Build a CodedEvent instance appropriate for the provided SpacecraftState.
buildOccurrenceCodedEvent(SpacecraftState, boolean) - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
buildOccurrenceCodedEvent(Map<String, SpacecraftState>, boolean) - Method in interface fr.cnes.sirius.patrius.events.multi.MultiCodingEventDetector
Build a CodedEvent instance appropriate for the provided map of SpacecraftState.
buildOccurrenceCodedEvent(Map<String, SpacecraftState>, boolean) - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
buildPhenomenaListMap(AbsoluteDateInterval, SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger
Builds a map of PhenomenaList, one list per CodingEventDetector instance.
buildPhenomenaListMap(AbsoluteDateInterval, Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger
Builds a map of PhenomenaList, one list per MultiCodingEventDetector instance.
buildQuaternionDPFacade(double[]) - Static method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.QuaternionDPFacade
factory method.
buildRotationDPFacade(double[]) - Static method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.RotationDPFacade
factory method.
buildTerm(double, double, int, int, int, int, int, int, int, int, int, int, int, int, int, int) - Static method in class org.orekit.data.SeriesTerm
Factory method for building the appropriate object.
buildUndefinedEvent(AbsoluteDate, boolean) - Static method in class fr.cnes.sirius.patrius.events.CodedEvent
Factory method for an undefined event, that still has a valid date.
BULLETINB_1980_FILENAME - Static variable in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Default regular expression for the BulletinB files (IAU1980 compatibles).
BULLETINB_2000_FILENAME - Static variable in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Default regular expression for the BulletinB files (IAU2000 compatibles).
BulletinBFilesLoader - Class in org.orekit.frames.configuration.eop
Loader for bulletin B files.
BulletinBFilesLoader(String) - Constructor for class org.orekit.frames.configuration.eop.BulletinBFilesLoader
Build a loader for IERS bulletins B files.
BX_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.forces.EmpiricalForce
X-component of the B coefficient.
BY_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.forces.EmpiricalForce
Y-component of the B coefficient.
byteValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a byte.
BZ_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.forces.EmpiricalForce
Z-component of the B coefficient.

C

c1 - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
C1 from SPTRCK #3.
C1AL - Static variable in class org.orekit.forces.radiation.KnockeRiesModel
coefficient c1al of Knocke-Ries model.
C1IR - Static variable in class org.orekit.forces.radiation.KnockeRiesModel
coefficient c1ir of Knocke-Ries model.
c2 - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
C2 from SPTRCK #3.
c4 - Variable in class org.orekit.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.AeroGlobalProperty
Default drag coefficient parameter name.
C_X - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Default drag force coefficient parameter name.
C_Z - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
Default lift coefficient parameter name.
calculateAdjustedRSquared() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Returns the adjusted R-squared statistic, defined by the formula
calculateBeta() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Calculates the beta of multiple linear regression in matrix notation.
calculateBeta() - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
Calculates beta by GLS.
calculateBeta() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Calculates the regression coefficients using OLS.
calculateBetaVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Calculates the beta variance of multiple linear regression in matrix notation.
calculateBetaVariance() - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
Calculates the variance on the beta.
calculateBetaVariance() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Calculates the variance-covariance matrix of the regression parameters.
calculateErrorVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Calculates the variance of the error term.
calculateErrorVariance() - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
Calculates the estimated variance of the error term using the formula
calculateField(double, double, double) - Method in class org.orekit.models.earth.GeoMagneticField
Calculate the magnetic field at the specified geodetic point identified by latitude, longitude and altitude.
calculateField(GeodeticPoint) - Method in class org.orekit.models.earth.GeoMagneticField
Calculate the magnetic field at the specified geodetic point identified by geodetic objet.
calculateField(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.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 org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Compute the "hat" matrix.
calculateNumericalMean() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
used by WeibullDistribution.getNumericalMean()
calculateNumericalMean() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Used by ZipfDistribution.getNumericalMean().
calculateNumericalVariance() - Method in class org.apache.commons.math3.distribution.FDistribution
used by FDistribution.getNumericalVariance()
calculateNumericalVariance() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Used by HypergeometricDistribution.getNumericalVariance().
calculateNumericalVariance() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
used by WeibullDistribution.getNumericalVariance()
calculateNumericalVariance() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Used by ZipfDistribution.getNumericalVariance().
calculatePathDelay(double, double) - Method in class org.orekit.models.earth.SaastamoinenModel
Calculates the tropospheric path delay for the signal path from a ground station to a satellite.
calculateResiduals() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Calculates the residuals of multiple linear regression in matrix notation.
calculateResidualSumOfSquares() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Returns the sum of squared residuals.
calculateRSquared() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Returns the R-Squared statistic, defined by the formula
calculateTotalSumOfSquares() - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Returns the sum of squared deviations of Y from its mean.
calculateYVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Calculates the variance of the y values.
call() - Method in class fr.cnes.sirius.validate.parallel.AbstractSimpleParallelTaskImpl
 
call() - Method in interface fr.cnes.sirius.validate.parallel.ParallelTask
 
callImpl() - Method in class fr.cnes.sirius.validate.parallel.AbstractSimpleParallelTaskImpl
Call implementation to be provided by the implementing class.
canIncrement() - Method in class org.apache.commons.math3.util.Incrementor
Checks whether a single increment is allowed.
canMap(GeodeticPoint) - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
Returns a boolean depending if the geodetic point can be map with the selected projection method.
canMap(GeodeticPoint) - Method in interface fr.cnes.sirius.patrius.projections.IProjection
Returns a boolean depending if the geodetic point can be map with the selected projection method.
canMap(GeodeticPoint) - Method in class fr.cnes.sirius.patrius.projections.Mercator
Returns a boolean depending if the geodetic point can be map with the selected projection method.
CardanMountPosition - Class in org.orekit.utils
 
CardanMountPosition(double, double, double) - Constructor for class org.orekit.utils.CardanMountPosition
Build Cardan mount.
CardanMountPV - Class in org.orekit.utils
 
CardanMountPV(double, double, double, double, double, double) - Constructor for class org.orekit.utils.CardanMountPV
Build cardan mounting.
CartesianDerivativesFilter - Enum in org.orekit.utils
Enumerate for selecting which derivatives to use in TimeStampedPVCoordinates and interpolation.
CartesianOrbit - Class in org.orekit.orbits
This class holds cartesian orbital parameters.
CartesianOrbit(IOrbitalParameters, Frame, AbsoluteDate) - Constructor for class org.orekit.orbits.CartesianOrbit
Creates a new instance.
CartesianOrbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.CartesianOrbit
Constructor from cartesian parameters.
CartesianOrbit(Orbit) - Constructor for class org.orekit.orbits.CartesianOrbit
Constructor from any kind of orbital parameters.
CartesianParameters - Class in org.orekit.orbits.orbitalparameters
This class holds cartesian orbital parameters.
CartesianParameters(PVCoordinates, double) - Constructor for class org.orekit.orbits.orbitalparameters.CartesianParameters
Constructor with PV coordinates.
CartesianParameters(Vector3D, Vector3D, Vector3D, double) - Constructor for class org.orekit.orbits.orbitalparameters.CartesianParameters
Constructor with position and velocity.
CauchyDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Cauchy distribution.
CauchyDistribution() - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
Creates a Cauchy distribution with the median equal to zero and scale equal to one.
CauchyDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
Creates a Cauchy distribution using the given median and scale.
CauchyDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
Creates a Cauchy distribution using the given median and scale.
CauchyDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.CauchyDistribution
Creates a Cauchy distribution.
cbrt() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Cubic root.
Cbrt - Class in org.apache.commons.math3.analysis.function
Cube root function.
Cbrt() - Constructor for class org.apache.commons.math3.analysis.function.Cbrt
 
cbrt() - Method in interface org.apache.commons.math3.RealFieldElement
Cubic root.
cbrt(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the cubic root of a number.
ccor(double, double, double, double) - Method in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
ccor.
CHEMISTRY/DISSOCIATION CORRECTION FOR MSIS MODELS.
ccor2(double, double, double, double, double) - Method in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
ccor2.
CHEMISTRY/DISSOCIATION CORRECTION FOR MSIS MODELS
CCSDS_EPOCH - Static variable in class org.orekit.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 org.orekit.time.DateComponents
Reference epoch for CCSDS Time Code Format (CCSDS 301.0-B-4): 1958-01-01.
cdf(double) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the smallest whole number larger than instance.
Ceil - Class in org.apache.commons.math3.analysis.function
ceil function.
Ceil() - Constructor for class org.apache.commons.math3.analysis.function.Ceil
 
ceil() - Method in class org.apache.commons.math3.dfp.Dfp
Round to an integer using the round ceil mode.
ceil() - Method in interface org.apache.commons.math3.RealFieldElement
Get the smallest whole number larger than instance.
ceil(double) - Static method in class org.apache.commons.math3.util.FastMath
Get the smallest whole number larger than x.
celestialBodiesMaskingDistance(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Computes the minimal euclidian distance to the celestial body shapes.
CelestialBody - Interface in org.orekit.bodies
Interface for celestial bodies like Sun, Moon or solar system planets.
CelestialBodyFactory - Class in org.orekit.bodies
Factory class for bodies of the solar system.
CelestialBodyLoader - Interface in org.orekit.bodies
Interface for loading celestial bodies.
CelestialBodyPointed - Class in org.orekit.attitudes
This class handles a celestial body pointed attitude provider.
CelestialBodyPointed(Frame, PVCoordinatesProvider, Vector3D, Vector3D, Vector3D) - Constructor for class org.orekit.attitudes.CelestialBodyPointed
Creates new instance.
CelestialBodyPolesAxisDirection - Class in org.orekit.attitudes.directions
This direction is the axis defined by the two poles of a celestial body.
CelestialBodyPolesAxisDirection(CelestialBody) - Constructor for class org.orekit.attitudes.directions.CelestialBodyPolesAxisDirection
Build a direction defined by the frame associated to a celestial body.
CentralBodyMaskCircularFOVDetector - Class in fr.cnes.sirius.patrius.events
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
CentralBodyMaskCircularFOVDetector(PVCoordinatesProvider, double, GeometricBodyShape, boolean, Vector3D, double, double, double) - Constructor for class fr.cnes.sirius.patrius.events.CentralBodyMaskCircularFOVDetector
Constructor with user maxcheck and threshold creating a circularFOVDetector and an EllipsoidEclipseDetector
CentralBodyMaskCircularFOVDetector(PVCoordinatesProvider, double, GeometricBodyShape, boolean, Vector3D, double, double, double, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.CentralBodyMaskCircularFOVDetector
Constructor with user maxcheck and threshold creating a circularFOVDetector and an EllipsoidEclipseDetector
CentralBodyMaskCircularFOVDetector(PVCoordinatesProvider, double, GeometricBodyShape, boolean, Vector3D, double, double, double, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.CentralBodyMaskCircularFOVDetector
Constructor with user maxcheck and threshold creating a circularFOVDetector and an EllipsoidEclipseDetector
CentralBodyMaskCircularFOVDetector(PVCoordinatesProvider, double, GeometricBodyShape, boolean, Vector3D, double) - Constructor for class fr.cnes.sirius.patrius.events.CentralBodyMaskCircularFOVDetector
Constructor with default maxcheck and default threshold, creating a circularFOVDetector and an EllipsoidEclipseDetector
centroidOf(Collection<T>) - Method in interface org.apache.commons.math3.stat.clustering.Clusterable
Returns the centroid of the given Collection of points.
centroidOf(Collection<EuclideanDoublePoint>) - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Returns the centroid of the given Collection of points.
centroidOf(Collection<EuclideanIntegerPoint>) - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Returns the centroid of the given Collection of points.
CGU - Static variable in interface org.orekit.utils.CnesConstants
OBELIX gravitational constant.
checkAdditionCompatible(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Check if a matrix is addition compatible with the instance.
checkAdditionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if matrices are addition compatible.
checkApSanity(double) - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityToolbox
Check that the specified ap coefficient is within bounds
checkBinomial(int, int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Check binomial preconditions.
checkBounds(double) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
Returns spacecraftstate on bounds if duration is on bounds.
checkColumnIndex(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Check if a column index is valid.
checkColumnIndex(AnyMatrix, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if a column index is valid.
checkCompatibility(DSCompiler) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Check rules set compatibility.
checkContractExpand(float, float) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Please use ResizableDoubleArray.checkContractExpand(double,double) instead.
checkContractExpand(double, double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Checks the expansion factor and the contraction criterion and raises an exception if the contraction criterion is smaller than the expansion criterion.
checkDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.guidance.GuidanceProfile
Check date validity
checkEOPContinuity(double) - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Check Earth orientation parameters continuity.
checkFinite(double) - Static method in class org.apache.commons.math3.util.MathUtils
Check that the argument is a real number.
checkFinite(double[]) - Static method in class org.apache.commons.math3.util.MathUtils
Check that all the elements are real numbers.
checkIndex(int) - Method in class org.apache.commons.math3.linear.RealVector
Check if an index is valid.
checkIndices(int, int) - Method in class org.apache.commons.math3.linear.RealVector
Checks that the indices of a subvector are valid.
checkKpSanity(double) - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityToolbox
Check that the specified kp coefficient is within bounds
checkMatrixIndex(AnyMatrix, int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if matrix indices are valid.
checkMultiplicationCompatible(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Check if a matrix is multiplication compatible with the instance.
checkMultiplicationCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if matrices are multiplication compatible
checkNonNegative(long[]) - Static method in class org.apache.commons.math3.util.MathArrays
Check that all entries of the input array are >= 0.
checkNonNegative(long[][]) - Static method in class org.apache.commons.math3.util.MathArrays
Check all entries of the input array are >= 0.
checkNotNull(Object, Localizable, Object...) - Static method in class org.apache.commons.math3.util.MathUtils
Checks that an object is not null.
checkNotNull(Object) - Static method in class org.apache.commons.math3.util.MathUtils
Checks that an object is not null.
checkOrder(double[], MathArrays.OrderDirection, boolean, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that the given array is sorted.
checkOrder(double[], MathArrays.OrderDirection, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that the given array is sorted.
checkOrder(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Check that the given array is sorted in strictly increasing order.
checkParameters(RealLinearOperator, RealVector, RealVector) - Static method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.geometry.euclidean.oned.Interval
Check a point with respect to the interval.
checkPoint(Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check a point with respect to the region.
checkPoint(BSPTree<S>, Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check a point with respect to the region starting at a given node.
checkPoint(Vector<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check a point with respect to the region.
checkPolygonSet() - Method in class org.apache.commons.math3.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.PolygonsSet(Vector2D[][]) is used, second exception cannot be reached (vertices are automatically sorted in TRIGO sense, which prevent crossing borders) If constructor PolygonsSet.PolygonsSet(Vector2D[][]) is used, third exception cannot be reached (the first will be reached before)
checkPositive(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Check that all entries of the input array are strictly positive.
checkRectangular(long[][]) - Static method in class org.apache.commons.math3.util.MathArrays
Throws DimensionMismatchException if the input array is not rectangular.
checkRowIndex(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Check if a row index is valid.
checkRowIndex(AnyMatrix, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if a row index is valid.
checkSubMatrixIndex(int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Check if submatrix ranges indices are valid.
checkSubMatrixIndex(int[], int[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Check if submatrix ranges indices are valid.
checkSubMatrixIndex(AnyMatrix, int, int, int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if submatrix ranges indices are valid.
checkSubMatrixIndex(AnyMatrix, int[], int[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if submatrix ranges indices are valid.
checkSubtractionCompatible(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Check if a matrix is subtraction compatible with the instance.
checkSubtractionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Check if matrices are subtraction compatible
checkSymmetric(RealMatrix, double) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Checks whether a matrix is symmetric.
checkValidity(List<T>) - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
Asserts that representation can represent a valid chromosome.
checkValidity(List<Integer>) - Method in class org.apache.commons.math3.genetics.BinaryChromosome
Asserts that representation can represent a valid chromosome.
checkValidity(List<Double>) - Method in class org.apache.commons.math3.genetics.RandomKey
Asserts that representation can represent a valid chromosome.
checkVectorDimensions(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Check if instance and specified vectors have the same dimension.
checkVectorDimensions(int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Check if instance dimension is equal to some expected value.
checkVectorDimensions(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Check if instance and specified vectors have the same dimension.
checkVectorDimensions(int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Check if instance dimension is equal to some expected value.
checkVectorDimensions(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Check if instance and specified vectors have the same dimension.
checkVectorDimensions(int) - Method in class org.apache.commons.math3.linear.RealVector
Check if instance dimension is equal to some expected value.
checkVectorDimensions(int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Check if instance dimension is equal to some expected value.
chiSquare(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Computes the Chi-Square statistic comparing observed and expected frequency counts.
chiSquare(long[][]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Computes the Chi-Square statistic associated with a chi-square test of independence based on the input counts array, viewed as a two-way table.
chiSquare(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquare(long[][]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Computes a Chi-Square two sample test statistic comparing bin frequency counts in observed1 and observed2.
chiSquareDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
ChiSquaredDistribution - Class in org.apache.commons.math3.distribution
Implementation of the chi-squared distribution.
ChiSquaredDistribution(double) - Constructor for class org.apache.commons.math3.distribution.ChiSquaredDistribution
Create a Chi-Squared distribution with the given degrees of freedom.
ChiSquaredDistribution(double, double) - Constructor for class org.apache.commons.math3.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 org.apache.commons.math3.distribution.ChiSquaredDistribution
Create a Chi-Squared distribution with the given degrees of freedom and inverse cumulative probability accuracy.
ChiSquareTest - Class in org.apache.commons.math3.stat.inference
Implements Chi-Square test statistics.
ChiSquareTest() - Constructor for class org.apache.commons.math3.stat.inference.ChiSquareTest
Construct a ChiSquareTest
chiSquareTest(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.ChiSquareTest
Returns the observed significance level, or p-value, associated with a Chi-square goodness of fit test comparing the observed frequency counts to those in the expected array.
chiSquareTest(double[], long[], double) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.stat.inference.ChiSquareTest
Returns the observed significance level, or p-value, associated with a chi-square test of independence based on the input counts array, viewed as a two-way table.
chiSquareTest(long[][], double) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTest(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTest(long[][], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTest(long[][]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.stat.inference.ChiSquareTest
Performs a Chi-Square two sample test comparing two binned data sets.
chiSquareTestDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
CholeskyDecomposition - Class in org.apache.commons.math3.linear
Calculates the Cholesky decomposition of a matrix.
CholeskyDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.CholeskyDecomposition
Calculates the Cholesky decomposition of the given matrix.
CholeskyDecomposition(RealMatrix, double, double) - Constructor for class org.apache.commons.math3.linear.CholeskyDecomposition
Calculates the Cholesky decomposition of the given matrix.
Chromosome - Class in org.apache.commons.math3.genetics
Individual in a population.
Chromosome() - Constructor for class org.apache.commons.math3.genetics.Chromosome
 
ChromosomePair - Class in org.apache.commons.math3.genetics
A pair of Chromosome objects.
ChromosomePair(Chromosome, Chromosome) - Constructor for class org.apache.commons.math3.genetics.ChromosomePair
Create a chromosome pair.
ChronologicalComparator - Class in org.orekit.time
Comparator for TimeStamped instance.
ChronologicalComparator() - Constructor for class org.orekit.time.ChronologicalComparator
Simple constructor.
CIPCoordinates - Class in org.orekit.frames.configuration.precessionnutation
This class represents a Celestial Intermediate Pole.
CIPCoordinates(AbsoluteDate, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
 
CIPCoordinates(AbsoluteDate, double[], double[]) - Constructor for class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
 
CIPCoordinatesGenerator - Class in org.orekit.frames.configuration.precessionnutation
The class generates CIPCoordinates to be used independently or within a TimeStampedCache.
CIPCoordinatesGenerator(PrecessionNutationModel, int, double) - Constructor for class org.orekit.frames.configuration.precessionnutation.CIPCoordinatesGenerator
Constructor.
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 org.orekit.propagation.events
Finder for target entry/exit events with respect to a satellite sensor field of view.
CircularFieldOfViewDetector(PVCoordinatesProvider, Vector3D, double, double) - Constructor for class org.orekit.propagation.events.CircularFieldOfViewDetector
Build a new instance.
CircularFieldOfViewDetector(PVCoordinatesProvider, Vector3D, double, double, double) - Constructor for class org.orekit.propagation.events.CircularFieldOfViewDetector
Build a new instance.
CircularFieldOfViewDetector(PVCoordinatesProvider, Vector3D, double, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.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 org.orekit.propagation.events.CircularFieldOfViewDetector
Build a new instance with defined actions at fov entry and exit.
CircularOrbit - Class in org.orekit.orbits
This class handles circular orbital parameters.
CircularOrbit(IOrbitalParameters, Frame, AbsoluteDate) - Constructor for class org.orekit.orbits.CircularOrbit
Creates a new instance.
CircularOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.CircularOrbit
Creates a new instance.
CircularOrbit(double, double, double, double, double, double, int, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.CircularOrbit
Deprecated. as of 6.0 replaced by CircularOrbit.CircularOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double)
CircularOrbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.CircularOrbit
Constructor from cartesian parameters.
CircularOrbit(Orbit) - Constructor for class org.orekit.orbits.CircularOrbit
Constructor from any kind of orbital parameters.
CircularParameters - Class in org.orekit.orbits.orbitalparameters
This class handles circular orbital parameters.
CircularParameters(double, double, double, double, double, double, PositionAngle, double) - Constructor for class org.orekit.orbits.orbitalparameters.CircularParameters
Creates a new instance.
CIRFProvider - Class in org.orekit.frames.transformations
Celestial Intermediate Reference Frame 2000.
CIRFProvider() - Constructor for class org.orekit.frames.transformations.CIRFProvider
Simple constructor.
classes() - Method in class org.apache.commons.math3.util.TransformerMap
Returns the Set of Classes used as keys in the map.
ClassicalMSISE2000SolarData - Class in org.orekit.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 org.orekit.forces.atmospheres.solarActivity.specialized.ClassicalMSISE2000SolarData
Constructor.
ClassicalRungeKuttaIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the classical fourth order Runge-Kutta integrator for Ordinary Differential Equations (it is the most often used Runge-Kutta method).
ClassicalRungeKuttaIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.ClassicalRungeKuttaIntegrator
Simple constructor.
classify() - Method in class org.apache.commons.math3.dfp.Dfp
Returns the type - one of FINITE, INFINITE, SNAN, QNAN.
ClasspathCrawler - Class in org.orekit.data
Provider for data files stored as resources in the classpath.
ClasspathCrawler(String...) - Constructor for class org.orekit.data.ClasspathCrawler
Build a data classpath crawler.
ClasspathCrawler(ClassLoader, String...) - Constructor for class org.orekit.data.ClasspathCrawler
Build a data classpath crawler.
clean() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
clean the output directory
clear() - Method in class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Method that will called in order to clear all stored optima.
clear() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
Method that will called in order to clear all stored optima.
clear() - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultiStartMultivariateVectorOptimizer
Method that will called in order to clear all stored optima.
clear() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Clears the cache used by the default implementation of AbstractRandomGenerator.nextGaussian().
clear() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Clears the cache used by the default implementation of BitsStreamGenerator.nextGaussian.
clear() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Clears the internal state of the Statistic
clear() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math3.stat.Frequency
Clears the frequency table
clear() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
As the name suggests, clear wipes the internals and reorders everything in the canonical order.
clear() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Clears all data from the model.
clear() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Clears internal buffers and resets the regression model.
clear() - Method in interface org.apache.commons.math3.util.DoubleArray
Clear the double array
clear() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Clear the array contents, resetting the number of elements to zero.
clear() - Method in class org.apache.commons.math3.util.TransformerMap
Clears all the Class to Transformer mappings.
clearCelestialBodyLoaders(String) - Static method in class org.orekit.bodies.CelestialBodyFactory
Clear loaders for one celestial body.
clearCelestialBodyLoaders() - Static method in class org.orekit.bodies.CelestialBodyFactory
Clear loaders for all celestial bodies.
clearEOP1980HistoryLoaders() - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Clear loaders for EOP 1980 history.
clearEOP2000HistoryLoaders() - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Clear loaders for EOP 2000 history.
clearEventHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Remove all the event handlers that have been added to the integrator.
clearEventHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Remove all the event handlers that have been added to the integrator.
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
 
clearEventsDetectors() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Remove all events detectors.
clearEventsDetectors() - Method in class org.orekit.propagation.AbstractPropagator
Remove all events detectors.
clearEventsDetectors() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Remove all events detectors.
clearEventsDetectors() - Method in interface org.orekit.propagation.Propagator
Remove all events detectors.
clearGeoMagneticModelReaders() - Static method in class org.orekit.models.earth.GeoMagneticFieldFactory
Clear geomagnetic models readers.
clearIEEEFlags() - Method in class org.apache.commons.math3.dfp.DfpField
Clears the IEEE 854 status flags.
clearLoadedDataNames() - Method in class org.orekit.data.DataProvidersManager
Clear the set of data file names that have been loaded.
clearLoggedEvents() - Method in class fr.cnes.sirius.patrius.events.multi.MultiEventsLogger
Clear the logged events.
clearLoggedEvents() - Method in class org.orekit.propagation.events.EventsLogger
Clear the logged events.
clearModels() - Static method in class org.orekit.models.earth.GeoMagneticFieldFactory
Method to reset igrf and wmm models to null.
clearObservations() - Method in class org.apache.commons.math3.fitting.CurveFitter
Remove all observations.
clearObservations() - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated. Remove all observations.
clearOceanTidesCoefficientsReaders() - Static method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsFactory
Clear ocean tides coefficients READERS.
clearPotentialCoefficientsReaders() - Static method in class org.orekit.forces.gravity.potential.GravityFieldFactory
Clear gravity field READERS.
clearProviders() - Method in class org.orekit.data.DataProvidersManager
Remove all data providers.
clearSolarActivityDataReaders() - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataFactory
Clear solar activity READERS.
clearStepHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Remove all the step handlers that have been added to the integrator.
clearStepHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Remove all the step handlers that have been added to the integrator.
clearUTCTAILoaders() - Static method in class org.orekit.time.TimeScalesFactory
Clear loaders for UTC-TAI offsets history files.
clearVariablePotentialCoefficientsReaders() - Static method in class org.orekit.forces.gravity.variations.coefficients.VariableGravityFieldFactory
Clear readers
clone() - Method in class org.orekit.propagation.numerical.AdditionalStateInfo
Copy of the AdditionalStateInfo.
closeReplayFile() - Method in class org.apache.commons.math3.random.ValueServer
Closes valuesFileURL after use in REPLAY_MODE.
closestPoint(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Compute the point of the instance closest to another line.
closestPointTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
Computes the point on the ellipse closest to a point.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Vector3D) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
This method computes the point on the line that is the closest to the ellipsoid.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Vector3D) - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Computes the closest point on the cone to a user specified point
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Calculate the closest point to a line
closestPointTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
Computes the closest point on the cone to a user specified point
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
Calculate closest point to a line
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCone
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Computes the points of this and another line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.LineSegment
Computation of the closest point to a line, and the associated point of the line;
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in interface org.apache.commons.math3.geometry.euclidean.threed.Shape
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Computes the points of the shape and the line realizing the shortest distance.
closestPointTo(Vector3D) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.geometry.euclidean.threed.SphericalCap
Computes the points of the shape and the line realizing the shortest distance.
Cluster<T extends Clusterable<T>> - Class in org.apache.commons.math3.stat.clustering
Cluster holding a set of Clusterable points.
Cluster(T) - Constructor for class org.apache.commons.math3.stat.clustering.Cluster
Build a cluster centered at a specified point.
cluster(Collection<T>) - Method in class org.apache.commons.math3.stat.clustering.DBSCANClusterer
Performs DBSCAN cluster analysis.
cluster(Collection<T>, int, int, int) - Method in class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
Runs the K-means++ clustering algorithm.
cluster(Collection<T>, int, int) - Method in class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
Runs the K-means++ clustering algorithm.
Clusterable<T> - Interface in org.apache.commons.math3.stat.clustering
Interface for points that can be clustered together.
CMAESOptimizer - Class in org.apache.commons.math3.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 org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
CMAESOptimizer - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
CMAESOptimizer() - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. As of version 3.1: Parameter lambda must be passed with the call to optimize (whereas in the current code it is set to an undocumented value).
CMAESOptimizer(int) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. As of version 3.1: Parameter lambda must be passed with the call to optimize (whereas in the current code it is set to an undocumented value)..
CMAESOptimizer(int, double[]) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. As of version 3.1: Parameters lambda and inputSigma must be passed with the call to optimize.
CMAESOptimizer(int, double[], int, double, boolean, int, int, RandomGenerator, boolean) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. See SimpleValueChecker.SimpleValueChecker()
CMAESOptimizer(int, double[], int, double, boolean, int, int, RandomGenerator, boolean, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. As of version 3.1: Parameters lambda and inputSigma must be passed with the call to optimize.
CMAESOptimizer(int, double, boolean, int, int, RandomGenerator, boolean, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.  
CMAESOptimizer.PopulationSize - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
Population size.
CMAESOptimizer.PopulationSize(int) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer.PopulationSize
 
CMAESOptimizer.PopulationSize - Class in org.apache.commons.math3.optimization.direct
Deprecated. Population size.
CMAESOptimizer.PopulationSize(int) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer.PopulationSize
Deprecated.  
CMAESOptimizer.Sigma - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
Input sigma values.
CMAESOptimizer.Sigma(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer.Sigma
 
CMAESOptimizer.Sigma - Class in org.apache.commons.math3.optimization.direct
Deprecated. Input sigma values.
CMAESOptimizer.Sigma(double[]) - Constructor for class org.apache.commons.math3.optimization.direct.CMAESOptimizer.Sigma
Deprecated.  
CNES_STELA_AE - Static variable in interface org.orekit.utils.CnesConstants
CNES Stela reference equatorial radius.
CNES_STELA_MU - Static variable in interface org.orekit.utils.CnesConstants
CNES Stela reference mu.
CNES_STELA_UA - Static variable in interface org.orekit.utils.CnesConstants
UA from the 1992 Astronomical Almanac by P.
CnesConstants - Interface in org.orekit.utils
CNES added constants class test.
code() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
Get a hashcode for this set.
CodedEvent - Class in fr.cnes.sirius.patrius.events
This class represents an event occurrence.
An event is identified by a code (its name), the date of occurrence, a string representing a comment and a flag that indicates if the event is a "starting" event (i.e.
CodedEvent(String, String, AbsoluteDate, boolean) - Constructor for class fr.cnes.sirius.patrius.events.CodedEvent
Constructor for the coded event.
CodedEventsList - Class in fr.cnes.sirius.patrius.events
This class represents a list of objects CodedEvent.
One or more lists of coded events are created during propagation when CodingEventDetector is used, via the monitorDetector method.
CodedEventsList() - Constructor for class fr.cnes.sirius.patrius.events.CodedEventsList
Default constructor.
CodedEventsLogger - Class in fr.cnes.sirius.patrius.events
This class logs coded events during propagation.
CodedEventsLogger() - Constructor for class fr.cnes.sirius.patrius.events.CodedEventsLogger
Default constructor.
CodedEventsLogger.LoggedCodedEvent - Class in fr.cnes.sirius.patrius.events
This class is used to store the coded event with contextual information.
CodingEventDetector - Interface in fr.cnes.sirius.patrius.events
This interface represents an event detector that is able to build a CodedEvent object.
coef - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
coef for SGP C3 computation.
coef1 - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
coef for SGP C5 computation.
coefficientsC - Variable in class org.orekit.forces.gravity.tides.AbstractTides
First normalized potential tesseral coefficients array.
coefficientsCPD - Variable in class org.orekit.forces.gravity.tides.AbstractTides
First normalized potential tesseral coefficients array for partial derivatives computation.
coefficientsS - Variable in class org.orekit.forces.gravity.tides.AbstractTides
Second normalized potential tesseral coefficients array.
coefficientsSPD - Variable in class org.orekit.forces.gravity.tides.AbstractTides
Second normalized potential tesseral coefficients array for partial derivatives computation.
COFFileFormatReader - Class in org.orekit.models.earth
Reader for COF file formats for geomagnetic models.
COFFileFormatReader(String) - Constructor for class org.orekit.models.earth.COFFileFormatReader
Constructor.
collector(BivariateFunction, UnivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Returns a MultivariateFunction h(x[]) defined by
collector(BivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Returns a MultivariateFunction h(x[]) defined by
cols - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1.
Combinations - Class in org.apache.commons.math3.util
Utility to create combinations (n, k) of k elements in a set of n elements.
Combinations(int, int) - Constructor for class org.apache.commons.math3.util.Combinations
Creates an instance whose range is the k-element subsets of {0, ..., n - 1} represented as int[] arrays.
CombinatoricsUtils - Class in org.apache.commons.math3.util
Combinatorial utilities.
combine(BivariateFunction, UnivariateFunction, UnivariateFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Returns the univariate function
h(x) = combiner(f(x), g(x)).
combine(double, double, RealVector) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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
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.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.CombinedPhenomenaDetector
Constructor for the detector of the combination of two phenomena.
combineToSelf(double, double, RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Updates this with the linear combination of this and y.
combineToSelf(double, double, RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Updates this with the linear combination of this and y.
ComparableInterval<T extends Comparable<T>> - Class in org.orekit.utils
- Class describing an interval of Comparable data.
ComparableInterval(IntervalEndpointType, T, T, IntervalEndpointType) - Constructor for class org.orekit.utils.ComparableInterval
Constructor.
The input parameters have to be not null.
The lower and upper endpoints also have to be properly ordered.
Otherwise a MathIllegalArgumentException is thrown.
comparator() - Method in class org.apache.commons.math3.util.Combinations
Defines a lexicographic ordering of combinations.
comparatorPermutation(List<S>, Comparator<S>) - Static method in class org.apache.commons.math3.genetics.RandomKey
Generates a representation of a permutation corresponding to the data sorted by comparator.
Comparators - Class in fr.cnes.sirius.patrius.utils
- Static comparison methods for real numbers
compare(Attitude, Attitude) - Method in class org.orekit.attitudes.AttitudeChronologicalComparator
Compare two Attitude instances.
compare(TimeStamped, TimeStamped) - Method in class org.orekit.time.ChronologicalComparator
Compare two time-stamped instances.
compareDurationTo(AbsoluteDateInterval) - Method in class org.orekit.utils.AbsoluteDateInterval
Checks if the duration of the interval is longer, shorter or equal to the duration of another interval.
It returns a positive integer if the duration is longer, a negative integer if the duration is shorter and zero if the durations of the two intervals are identical.
The method checks also the lower and upper end points of the intervals, considering that an interval with an open end point is shorter than an interval with the same duration and a closed end point.
compareFiles(URI, URI, URI) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
Uses the ephemeris comparison library to load the data contained in the file, compute the comparisons between the two files and with thresholds
compareFilesWithReport(URI, URI, URI, URI, URI) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
Uses the ephemeris comparison library to load the data contained in the file, compute the comparisons between the two files and with thresholds, and produce a report of the comparison.
compareLowerEndTo(ComparableInterval<T>) - Method in class org.orekit.utils.ComparableInterval
Compares the lower end point with the lower end point of the given interval.
compareTo(CodedEvent) - Method in class fr.cnes.sirius.patrius.events.CodedEvent
Compares two CodedEvent instances.
The ordering for CodedEvent is consistent with equals, so that a CodedEvent can be used in any SortedSet or SortedMap.
The ordering is : the ordering of the events' dates if they differ. if not, the alphabetical ordering of the code is used if they differ. if not, the alphabetical ordering of the comment is used if they differ. if not, the starting boolean is used (the starting event is "before").
compareTo(CodedEventsLogger.LoggedCodedEvent) - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger.LoggedCodedEvent
 
compareTo(MultiCodedEventsLogger.MultiLoggedCodedEvent) - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger.MultiLoggedCodedEvent
Compare two MultiLoggedCodedEvent with their internal date.
compareTo(Phenomenon) - Method in class fr.cnes.sirius.patrius.events.Phenomenon
Compares the Phenomenon instances.
If the beginning events differ, their comparison is the result.
compareTo(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
Compares this object to another based on size.
compareTo(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
Compares this object to another based on size.
compareTo(Chromosome) - Method in class org.apache.commons.math3.genetics.Chromosome
Compares two chromosomes based on their fitness.
compareTo(OrderedTuple) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
Compares this ordered T-uple with the specified object.
compareTo(BigReal) - Method in class org.apache.commons.math3.util.BigReal
compareTo(Decimal64) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.util.Precision
Compares two numbers given some amount of allowed error.
compareTo(double, double, int) - Static method in class org.apache.commons.math3.util.Precision
Compares two numbers given some amount of allowed error.
compareTo(AbsoluteDate) - Method in class org.orekit.time.AbsoluteDate
Compare the instance with another date.
compareTo(DateComponents) - Method in class org.orekit.time.DateComponents
compareTo(DateTimeComponents) - Method in class org.orekit.time.DateTimeComponents
compareTo(TimeComponents) - Method in class org.orekit.time.TimeComponents
compareTo(ComparableInterval<T>) - Method in class org.orekit.utils.ComparableInterval
Compares this interval with the specified interval.
compareToThresholds() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ComparisonData
Computes the margin of the data with respect to its thresholds.
compareUpperEndTo(ComparableInterval<T>) - Method in class org.orekit.utils.ComparableInterval
Compares the upper end point with the upper end point of the given interval.
ComparisonData - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class represents a set of results from a comparison of data objects
ComparisonData(ArrayList<ArrayList<Double>>) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.ComparisonData
Instantiates a new ComparisonData object.
ComparisonData(ArrayList<ArrayList<Double>>, ArrayList<Double>) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.ComparisonData
this constructor initialises the columns and the thresholds.
complainIfNotSupported(String) - Method in class org.apache.commons.math3.ode.AbstractParameterizable
Check if a parameter is supported and throw an IllegalArgumentException if not.
complement(int) - Method in class org.apache.commons.math3.dfp.Dfp
Negate the mantissa of this by computing the complement.
complementaryAngle(double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Computes the complementary (PI/2 - angle) of the input angle, and then tries to express it in the input interval.
Complex - Class in org.apache.commons.math3.complex
Representation of a Complex number, i.e.
Complex(double) - Constructor for class org.apache.commons.math3.complex.Complex
Create a complex number given only the real part.
Complex(double, double) - Constructor for class org.apache.commons.math3.complex.Complex
Create a complex number given the real and imaginary parts.
ComplexField - Class in org.apache.commons.math3.complex
Representation of the complex numbers field.
ComplexFormat - Class in org.apache.commons.math3.complex
Formats a Complex number in cartesian format "Re(c) + Im(c)i".
ComplexFormat() - Constructor for class org.apache.commons.math3.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 org.apache.commons.math3.complex.ComplexFormat
Create an instance with a custom number format for both real and imaginary parts.
ComplexFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.complex
Static implementations of common Complex utilities functions.
componentProvider(ElementaryMultiplicationTypes.ElementaryType, int, double) - Static method in class org.apache.commons.math3.analysis.polynomials.ElementaryMultiplicationTypes
This method provides the UnivariateFunction cos(intermediateOrder * omega * x) or sin
compose(double...) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute composition of the instance by a univariate function.
compose(double[], int, double[], double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute composition of a derivative structure by a function.
compose(UnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Composes functions.
compose(UnivariateDifferentiableFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Composes functions.
compose(DifferentiableUnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated. as of 3.1 replaced by FunctionUtils.compose(UnivariateDifferentiableFunction...)
ComposedAttitudeLaw - Class in org.orekit.attitudes
This class represents a composed attitude law, defined by a main attitude law provider and a chained list of orientation laws.
The main attitude law provides, for a given date, the dynamic frame representing the spacecraft orientation; this orientation is then progressively transformed using the orientation laws.
ComposedAttitudeLaw(AttitudeLaw, LinkedList<IOrientationLaw>) - Constructor for class org.orekit.attitudes.ComposedAttitudeLaw
Builds a composed attitude law from a man attitude law provider and a list of modifier orientation laws.
CompositeFormat - Class in org.apache.commons.math3.util
Base class for formatters of composite objects (complex numbers, vectors ...).
compute(MathArrays.Function) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Performs an operation on the addressable elements of the array.
compute(PVCoordinatesProvider) - Method in class org.orekit.attitudes.ConstantSpinSlew
 
compute(PVCoordinatesProvider) - Method in interface org.orekit.attitudes.Slew
Compute the slew corresponding to an orbital state.
compute(PVCoordinatesProvider) - Method in class org.orekit.attitudes.TwoSpinBiasSlew
 
computeAbsoluteDeviation(Data<Double>, Data<Double>, boolean) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.RawDataComparator
Computes the absolute deviation between the elements of two Data object.
computeAbsoluteDeviation(double, double, boolean) - Static method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.RawDataComparator
Computes the absolute deviation between two double precision values.
computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
 
computeAcceleration(PVCoordinates, LocalOrbitalFrame, Vector3D, Frame, SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
Method to compute the acceleration.
computeAcceleration(SpacecraftState) - Method in class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
 
computeAcceleration(StelaEquinoctialOrbit, PVCoordinates) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
Compute the acceleration due to the force.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.drag.DragForce
Compute the acceleration due to the force.
computeAcceleration(PVCoordinates, Frame, Atmosphere, AbsoluteDate, double, double) - Static method in class org.orekit.forces.drag.DragForce
Method to compute the acceleration.
computeAcceleration(SpacecraftState) - Method in interface org.orekit.forces.ForceModel
Compute the acceleration due to the force.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.gravity.BalminoAttractionModel
Compute the acceleration due to the force.
computeAcceleration(PVCoordinates) - Method in class org.orekit.forces.gravity.BalminoAttractionModel
Acceleration in body frame.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.gravity.CunninghamAttractionModel
Compute the acceleration due to the force.
computeAcceleration(PVCoordinates, AbsoluteDate) - Method in class org.orekit.forces.gravity.CunninghamAttractionModel
Method to compute the acceleration.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.gravity.DrozinerAttractionModel
Compute the acceleration due to the force.
computeAcceleration(PVCoordinates, AbsoluteDate) - Method in class org.orekit.forces.gravity.DrozinerAttractionModel
Method to compute the acceleration.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.gravity.NewtonianAttraction
Compute the acceleration due to the force.
computeAcceleration(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.forces.gravity.NewtonianAttraction
Method to compute the acceleration.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.gravity.ThirdBodyAttraction
Compute the acceleration due to the force.
computeAcceleration(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.forces.gravity.ThirdBodyAttraction
Method to compute the acceleration.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.gravity.tides.AbstractTides
Compute the acceleration due to the force.
computeAcceleration(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.AbstractTides
Method to compute the acceleration, from Balmino algorithm (see BalminoAttractionModel class).
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Compute the acceleration due to the force.
computeAcceleration(AbsoluteDate, PVCoordinates) - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Compute acceleration in rotating frame
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.maneuvers.ConstantThrustError
Compute the acceleration due to the force.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Compute the acceleration due to the force.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
 
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.radiation.RediffusedRadiationPressure
Compute the acceleration due to the force.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.radiation.SolarRadiationPressure
Compute the acceleration due to the force.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.relativistic.CoriolisRelativisticEffect
Compute the acceleration due to the force.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.relativistic.LenseThirringRelativisticEffect
Compute the acceleration due to the force.
computeAcceleration(SpacecraftState) - Method in class org.orekit.forces.relativistic.SchwarzschildRelativisticEffect
Compute the acceleration due to the force.
computeAngularVelocitiesHarmonicProfile(AttitudeLawLeg, PVCoordinatesProvider, Frame, AbsoluteDate, double, int, KinematicsToolkit.IntegrationType, double) - Static method in class fr.cnes.sirius.patrius.guidance.GuidanceProfileBuilder
Compute the angular velocities harmonic guidance profile.
computeBalminoAcceleration(PVCoordinates, double[][], double[][], double, double, int, int, HelmholtzPolynomial) - Static method in class org.orekit.forces.gravity.GravityToolbox
Method to compute the acceleration, from Balmino algorithm (see BalminoAttractionModel).
computeBearing(GeodeticPoint, GeodeticPoint) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute the bearing (azimuth) between two geodetic Points.
computeCode(double, int, int) - Static method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
Computes code of data set.
computeCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Calculate the coefficients of Lagrange polynomial from the interpolation data.
computeCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Calculate the normal polynomial coefficients given the Newton form.
computeComparison(boolean, Data<T>, Data<T>, boolean) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.DataComparator
Computes the deviation between the elements of two Data object.
computeConstantCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.HelmholtzPolynomial
Calculate the constant coefficients of the polynomial as per
computeCorrections(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.IERS2003TidalCorrection
Compute the partials of the tidal variations to the orthoweights.
computeCorrelationMatrix(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Computes the correlation matrix for the columns of the input matrix.
computeCorrelationMatrix(double[][]) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Computes the correlation matrix for the columns of the input rectangular array.
computeCorrelationMatrix(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Computes the Spearman's rank correlation matrix for the columns of the input matrix.
computeCorrelationMatrix(double[][]) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Computes the cost.
computeCost(double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. Computes the cost.
computeCovarianceMatrix(RealMatrix, boolean) - Method in class org.apache.commons.math3.stat.correlation.Covariance
Compute a covariance matrix from a matrix whose columns represent covariates.
computeCovarianceMatrix(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.Covariance
Create a covariance matrix from a matrix whose columns represent covariates.
computeCovarianceMatrix(double[][], boolean) - Method in class org.apache.commons.math3.stat.correlation.Covariance
Compute a covariance matrix from a rectangular array whose columns represent covariates.
computeCovarianceMatrix(double[][]) - Method in class org.apache.commons.math3.stat.correlation.Covariance
Create a covariance matrix from a rectangular array whose columns represent covariates.
computeCovariances(double[], double) - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Get the covariance matrix of the optimized parameters.
computeCovariances(double[], double) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. Get the covariance matrix of the optimized parameters.
computeCunninghamAcceleration(PVCoordinates, double, double[][], double[][], int, int, double) - Static method in class org.orekit.forces.gravity.GravityToolbox
Method to compute the acceleration.
computed - Variable in class org.orekit.attitudes.AbstractSlew
True if the slew has already been computed.
computeDAccDPos(PVCoordinates, AbsoluteDate, double, double, double[][], double[][]) - Static method in class org.orekit.forces.gravity.GravityToolbox
Compute the partial derivatives of the acceleration (Cunningham algorithm) with respect to the position.
computeDerivativeObjectiveValue(double) - Method in class org.apache.commons.math3.analysis.solvers.AbstractDifferentiableUnivariateSolver
Deprecated. Compute the objective function value.
computeDerivatives(SpacecraftState, TimeDerivativesEquations) - Method in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
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
 
computeDerivatives(StelaEquinoctialOrbit, double[], double[]) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaPartialDerivativesEquations
 
computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Compute the derivatives and check the number of evaluations.
computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get the current time derivative of the complete state vector.
computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math3.ode.FirstOrderConverter
Get the current time derivative of the state vector.
computeDerivatives(double, double[], double[]) - Method in interface org.apache.commons.math3.ode.FirstOrderDifferentialEquations
Get the current time derivative of the state vector.
computeDerivatives(double, double[], double[], double[], double[]) - Method in interface org.apache.commons.math3.ode.SecondaryEquations
Compute the derivatives related to the secondary state parameters.
computeDerivatives(SpacecraftState, TimeDerivativesEquations) - Method in interface org.orekit.propagation.numerical.AdditionalEquations
Compute the derivatives related to the additional state parameters.
computeDerivatives(SpacecraftState, TimeDerivativesEquations) - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Compute the derivatives related to the additional state parameters.
computeDeviationTo(boolean, DeviationProvider, boolean) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.DateDPFacade
computes the deviation in seconds between the stored date and the given one.
computeDeviationTo(boolean, DeviationProvider, boolean) - Method in interface fr.cnes.sirius.patrius.tools.ephemerisComparator.DeviationProvider
Computes the deviation from the current object (this) to the object in parameter.
computeDeviationTo(boolean, DeviationProvider, boolean) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.DoubleDPFacade
computes the relative deviation between the stored double value and the given one.
computeDeviationTo(boolean, DeviationProvider, boolean) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.PVCoordinatesDPFacade
computes the deviation in seconds between the stored PV and the given one.
computeDeviationTo(boolean, DeviationProvider, boolean) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.QuaternionDPFacade
computes the deviation in angle between the stored rotation and the given one.
computeDeviationTo(boolean, DeviationProvider, boolean) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.RotationDPFacade
computes the deviation in angle between the stored rotation and the given one.
computeDeviationTo(boolean, DeviationProvider, boolean) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.VectorDPFacade
computes the relative deviation between the stored vector value and the given one.
computeDistribution() - Method in class org.apache.commons.math3.random.ValueServer
Computes the empirical distribution using values from the file in valuesFileURL, using the default number of bins.
computeDistribution(int) - Method in class org.apache.commons.math3.random.ValueServer
Computes the empirical distribution using values from the file in valuesFileURL and binCount bins.
computeDividedDifference(double[], double[]) - Static method in class org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator
Return a copy of the divided difference array.
computeDrozinerAcceleration(PVCoordinates, Frame, double[][], double[][], double, double, double, int, int) - Static method in class org.orekit.forces.gravity.GravityToolbox
Method to compute the acceleration, from Droziner algorithm (see DrozinerAttractionModel).
computeElectronicCont(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.iono.BentModel
Computation of the electric content between the station and the satellite at a date.
computeElevationCorrection(double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.AngularCorrection
Computes the correction for the signal elevation.
computeElevationCorrection(double) - Method in class fr.cnes.sirius.patrius.signalpropagation.AzoulayModel
 
computeEquinoctialToCartesianJacobian(StelaEquinoctialOrbit) - Static method in class fr.cnes.sirius.patrius.stela.orbits.JacobianConverter
Computes Jacobian matrix from equinoctial to cartesian.
computeExp(Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.DfpField
Compute exp(a).
computeFundamentalArguments(AbsoluteDate, TidesStandards.TidesStandard) - Static method in class org.orekit.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.
computeGeometricalProperties() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Compute some geometrical properties.
computeGeometricalProperties() - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Compute some geometrical properties.
computeGeometricalProperties() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Compute some geometrical properties.
computeGeometricalProperties() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Compute some geometrical properties.
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 class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.drag.DragForce
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in interface org.orekit.forces.GradientModel
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.gravity.BalminoAttractionModel
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.gravity.CunninghamAttractionModel
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.gravity.DrozinerAttractionModel
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.gravity.NewtonianAttraction
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.gravity.ThirdBodyAttraction
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.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 org.orekit.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 org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.maneuvers.ConstantThrustError
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.radiation.RediffusedRadiationPressure
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.radiation.SolarRadiationPressure
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.relativistic.CoriolisRelativisticEffect
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.forces.relativistic.LenseThirringRelativisticEffect
This method returns true if the acceleration partial derivatives with respect to position have to be computed.
computeGradientPosition() - Method in class org.orekit.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.EmpiricalForce
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.PatriusSolarRadiationPressure
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.drag.DragForce
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in interface org.orekit.forces.GradientModel
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.gravity.BalminoAttractionModel
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.gravity.CunninghamAttractionModel
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.gravity.DrozinerAttractionModel
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.gravity.NewtonianAttraction
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.gravity.ThirdBodyAttraction
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.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 org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.maneuvers.ConstantThrustError
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.radiation.RediffusedRadiationPressure
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.radiation.SolarRadiationPressure
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.relativistic.CoriolisRelativisticEffect
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.relativistic.LenseThirringRelativisticEffect
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeGradientVelocity() - Method in class org.orekit.forces.relativistic.SchwarzschildRelativisticEffect
This method returns true if the acceleration partial derivatives with respect to velocity have to be computed.
computeHelmholtzPolynomial(Vector3D) - Method in class org.apache.commons.math3.analysis.polynomials.HelmholtzPolynomial
Calculate the value of the polynomial in a given point.
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 org.apache.commons.math3.ode.nonstiff.RungeKutta6StepInterpolator
Compute the state and derivatives at the interpolated time.
computeInterpolatedStateAndDerivatives(double, double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Compute the state and derivatives at the interpolated time.
computeInterpolatedStateAndDerivatives(double, double) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Compute the state and derivatives at the interpolated time.
computeInverseMeridionalDistance(double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute the geodetic latitude, from a distance from the equator.
computeInverseRectifyingLatitude(double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
compute geodetic latitude at a given rectifying latitude.
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.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 org.apache.commons.math3.optim.nonlinear.vector.JacobianMultivariateVectorOptimizer
Computes the Jacobian matrix.
computeJacobianCartesianWrtTrue() - Method in class org.orekit.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.stela.orbits.StelaEquinoctialOrbit
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
computeJacobianEccentricWrtCartesian() - Method in class org.orekit.orbits.ApsisOrbit
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
computeJacobianEccentricWrtCartesian() - Method in class org.orekit.orbits.CartesianOrbit
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
computeJacobianEccentricWrtCartesian() - Method in class org.orekit.orbits.CircularOrbit
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
computeJacobianEccentricWrtCartesian() - Method in class org.orekit.orbits.EquatorialOrbit
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
computeJacobianEccentricWrtCartesian() - Method in class org.orekit.orbits.EquinoctialOrbit
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
computeJacobianEccentricWrtCartesian() - Method in class org.orekit.orbits.KeplerianOrbit
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
computeJacobianEccentricWrtCartesian() - Method in class org.orekit.orbits.Orbit
Compute the Jacobian of the orbital parameters with eccentric angle with respect to the Cartesian parameters.
computeJacobianMeanWrtCartesian() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
 
computeJacobianMeanWrtCartesian() - Method in class org.orekit.orbits.ApsisOrbit
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
computeJacobianMeanWrtCartesian() - Method in class org.orekit.orbits.CartesianOrbit
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
computeJacobianMeanWrtCartesian() - Method in class org.orekit.orbits.CircularOrbit
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
computeJacobianMeanWrtCartesian() - Method in class org.orekit.orbits.EquatorialOrbit
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
computeJacobianMeanWrtCartesian() - Method in class org.orekit.orbits.EquinoctialOrbit
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
computeJacobianMeanWrtCartesian() - Method in class org.orekit.orbits.KeplerianOrbit
Compute the Jacobian of the orbital parameters with mean angle with respect to the Cartesian parameters.
computeJacobianMeanWrtCartesian() - Method in class org.orekit.orbits.Orbit
Compute the Jacobian of the orbital parameters with mean 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.
computeJacobianTrueWrtCartesian() - Method in class org.orekit.orbits.ApsisOrbit
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
computeJacobianTrueWrtCartesian() - Method in class org.orekit.orbits.CartesianOrbit
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
computeJacobianTrueWrtCartesian() - Method in class org.orekit.orbits.CircularOrbit
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
computeJacobianTrueWrtCartesian() - Method in class org.orekit.orbits.EquatorialOrbit
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
computeJacobianTrueWrtCartesian() - Method in class org.orekit.orbits.EquinoctialOrbit
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
computeJacobianTrueWrtCartesian() - Method in class org.orekit.orbits.KeplerianOrbit
Compute the Jacobian of the orbital parameters with true angle with respect to the Cartesian parameters.
computeJacobianTrueWrtCartesian() - Method in class org.orekit.orbits.Orbit
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 org.orekit.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.
computeLn(Dfp, Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.DfpField
Compute ln(a).
computeLoxodromicDistance(GeodeticPoint, GeodeticPoint) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
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 org.apache.commons.math3.ode.MainStateJacobianProvider
Compute the jacobian matrix of ODE with respect to main state.
computeMaxDuration() - Method in class org.orekit.attitudes.TwoSpinBiasSlew
Estimate the maximum duration of the slew, before computing it.
computeMeanLocalTime(AbsoluteDate, Vector3D, Frame, double) - Method in class org.orekit.time.LocalTime
Compute mean local time in provided frame.
computeMeanLocalTime(AbsoluteDate, Vector3D) - Method in class org.orekit.time.LocalTime
Compute mean local time in TIRF frame.
computeMeanOrbit(Orbit) - Method in class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Deprecated. use EcksteinHechlerPropagator.osc2mean(Orbit) instead
computeMercatorLatitude(double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute crescent latitude (Le) at a given geodetic latitude.
computeMeridionalDistance(double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute the distance from a given geodetic 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.
computeNutationArguments(double, TidesStandards.TidesStandard) - Static method in class org.orekit.forces.gravity.tides.TidesToolbox
Method to compute the fundamental arguments from the luni-solar nutation theory.
computeObjectiveGradient(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.GradientMultivariateOptimizer
Compute the gradient vector.
computeObjectiveGradient(double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractDifferentiableOptimizer
Deprecated. Compute the gradient vector.
computeObjectiveGradient(double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractScalarDifferentiableOptimizer
Deprecated. Compute the gradient vector.
computeObjectiveValue(double) - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Compute the objective function value.
computeObjectiveValue(double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Compute the objective function value.
computeObjectiveValue(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateOptimizer
Computes the objective function value.
computeObjectiveValue(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultivariateVectorOptimizer
Computes the objective function value.
computeObjectiveValue(double) - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
Computes the objective function value.
computeObjectiveValue(double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. Compute the objective function value.
computeObjectiveValue(double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Compute the objective function value.
computeObjectiveValue(double) - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated. Compute the objective function value.
computeObjectiveValueAndDerivative(double) - Method in class org.apache.commons.math3.analysis.solvers.AbstractUnivariateDifferentiableSolver
Compute the objective function value.
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.
computeOrthodromicDistance(GeodeticPoint, GeodeticPoint) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute the orthodromic distance between two points.
computeOrthodromicDistance(double, double, double, double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute the orthodromic distance.
computeParameterJacobian(double, double[], double[], String, double[]) - Method in interface org.apache.commons.math3.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
 
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
 
computePartialDerivatives(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.noninertial.NonInertialContribution
 
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.
computePathDelay(double) - Method in class org.orekit.models.earth.FixedDelayModel
Calculates the tropospheric path delay for the signal path from a ground station to a satellite.
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
 
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
 
computePerturbation(StelaEquinoctialOrbit, OrbitNatureConverter) - Method in class fr.cnes.sirius.patrius.stela.forces.noninertial.NonInertialContribution
 
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(GeodeticPoint, double, double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute the point coordinates from an origin point, an azimuth and a distance along the rhumb line (Loxodrome).
computePointAlongOrthodrome(GeodeticPoint, double, double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute a geodetic point along orthodrome, from a point p1, at a distance d, in a direction defined from an azimuth.
computePotentialPerturbation(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.StelaSRPSquaring
 
computeRadiusEastWest(double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute radius of curvature section East/West (also called M or Re).
computeRelativeDeviation(Data<Double>, Data<Double>, boolean) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.RawDataComparator
Computes the relative deviation between the elements of two Data object.
computeRelativeDeviation(double, double, double) - Static method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.RawDataComparator
Computes the relative deviation between two double precision values.
computeResiduals(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Computes the residuals.
computeResiduals(double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. Computes the residuals.
computeRoots(int) - Method in class org.apache.commons.math3.complex.RootsOfUnity
Computes the n-th roots of unity.
computeRule(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.BaseRuleFactory
Computes the rule for the given order.
computeRule(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.LegendreHighPrecisionRuleFactory
Computes the rule for the given order.
computeRule(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.LegendreRuleFactory
Computes the rule for the given order.
computeSecondDerivatives(double, double[], double[], double[]) - Method in interface org.apache.commons.math3.ode.SecondOrderDifferentialEquations
Get the current time derivative of the state vector.
computeSecular(Orbit, AbstractLyddanePropagator.LyddaneParametersType) - Method in class org.orekit.propagation.analytical.AbstractLyddanePropagator
Compute secular orbit in body frame from provided orbit.
computeShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAtmosphericDrag
 
computeShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
Compute the short periodic variations for a given spacecraft state.
computeShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
Compute the short periodic variations for a given spacecraft state.
computeShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaThirdBodyAttraction
 
computeShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
 
computeShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.noninertial.NonInertialContribution
 
computeShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPPotential
Compute the short periodic variations for a given spacecraft state.
computeShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
Compute the short periodic variations for a given spacecraft state.
computeShortPeriods(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.StelaSRPSquaring
Compute the short periodic variations for a given spacecraft state.
computeShortPeriods(StelaEquinoctialOrbit) - Method in interface fr.cnes.sirius.patrius.stela.forces.StelaForceModel
Compute the short periodic variations for a given spacecraft state.
computeSigma(double[], double) - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Computes an estimate of the standard deviation of the parameters.
computeSigma(double[], double) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. Computes an estimate of the standard deviation of the parameters.
computeSignalDelay(double) - Method in class fr.cnes.sirius.patrius.signalpropagation.AzoulayModel
 
computeSignalDelay(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.signalpropagation.iono.BentModel
 
computeSignalDelay(AbsoluteDate, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.signalpropagation.iono.IonosphericCorrection
Calculates the ionospheric signal delay for the signal path from the position of the transmitter and the receiver and the current date.
computeSignalDelay(double) - Method in class org.orekit.models.earth.FixedDelayModel
Calculates the tropospheric signal delay for the signal path from a ground station to a satellite.
computeSignalDelay(double, double) - Method in class org.orekit.models.earth.SaastamoinenModel
Calculates the tropospheric signal delay for the signal path from a ground station to a satellite.
computeSignalDelay(double) - Method in interface org.orekit.models.earth.TroposphericCorrection
Calculates the tropospheric signal delay for the signal path from a ground station to a satellite.
computeSignalPropagation(PVCoordinatesProvider, PVCoordinatesProvider, AbsoluteDate, SignalPropagationModel.FixedDate) - Method in class fr.cnes.sirius.patrius.signalpropagation.SignalPropagationModel
Computes the signal propagation object in the void at a particular date
computeSphericalAzimuth(GeodeticPoint, GeodeticPoint) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Compute the spherical azimuth (clock wise) between two points.
computeSpin(AbsoluteDate) - Method in class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Estimate the spin at a given date from the current OrientationFunction using the quaternions formula: Ω = 2 * Q' dQ, where Q' is the conjugate of the quaternion and dQ is the derivative of the quaternion at the given date.
computeSpin(Quaternion, Quaternion) - Static method in class org.orekit.attitudes.kinematics.KinematicsToolkit
Compute spin knowing the instantaneous quaternion and its derivative.
computeSpin(double[], double[], RotationOrder) - Static method in class org.orekit.attitudes.kinematics.KinematicsToolkit
Compute spin knowing the instantaneous quaternion and its derivative.
computeSpinFunction() - Method in class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Estimate the Vector3DFunction from the current OrientationFunction using the quaternions formula: Ω = 2 * Q' dQ, where Q' is the conjugate of the quaternion and dQ is the derivative of the quaternion at the given date.
computeSquaringPoints(int, StelaEquinoctialOrbit, double, double) - Static 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.
computeStep(AbsoluteDate, AbsoluteDateInterval) - Method in class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
Computes the step used during attitude ephemeris generation.
computeStep(AbsoluteDate, AbsoluteDateInterval) - Method in class org.orekit.attitudes.FixedStepAttitudeEphemerisGenerator
 
computeStep(AbsoluteDate, AbsoluteDateInterval) - Method in class org.orekit.attitudes.VariableStepAttitudeEphemerisGenerator
Computes the step used during the variable step ephemeris generation.
computeStepGrowShrinkFactor(double) - Method in class org.apache.commons.math3.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.
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 org.orekit.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 org.orekit.wrenches.WrenchModel
Compute the resulting wrench.
computeTrueLocalTime(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.time.LocalTime
Compute true local time in provided frame in the range ] -43200s; 43200s ].
computeTrueLocalTime(AbsoluteDate, Vector3D) - Method in class org.orekit.time.LocalTime
Compute true local time in TIRF frame.
computeWeightedJacobian(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Computes the weighted Jacobian matrix.
computeWeightedJacobian(double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. Computes the 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 org.orekit.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 org.orekit.wrenches.WrenchModel
Compute the resulting wrench.
Cone - Interface in org.apache.commons.math3.geometry.euclidean.threed
This interface extends the solid shape for the particular case of cones.
conjugate() - Method in class org.apache.commons.math3.complex.Complex
Return the conjugate of this complex number.
ConjugateGradient - Class in org.apache.commons.math3.linear
This is an implementation of the conjugate gradient method for RealLinearOperator.
ConjugateGradient(int, double, boolean) - Constructor for class org.apache.commons.math3.linear.ConjugateGradient
Creates a new instance of this class, with default stopping criterion.
ConjugateGradient(IterationManager, double, boolean) - Constructor for class org.apache.commons.math3.linear.ConjugateGradient
Creates a new instance of this class, with default stopping criterion and custom iteration manager.
ConjugateGradientFormula - Enum in org.apache.commons.math3.optimization.general
Deprecated. As of 3.1 (to be removed in 4.0).
CONST_SOL_N_M2 - Static variable in interface org.orekit.utils.CnesConstants
Solar constant (N/M**2).
CONST_SOL_STELA - Static variable in interface org.orekit.utils.CnesConstants
Solar Constant (N/M**2).
CONST_SOL_W_M2 - Static variable in interface org.orekit.utils.CnesConstants
Solar constant (W/M**2).
Constant - Class in org.apache.commons.math3.analysis.function
Constant function.
Constant(double) - Constructor for class org.apache.commons.math3.analysis.function.Constant
 
CONSTANT_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Always return mu
ConstantAttitudeLaw - Class in org.orekit.attitudes
This class handles a constant attitude law.
ConstantAttitudeLaw(Frame, Rotation) - Constructor for class org.orekit.attitudes.ConstantAttitudeLaw
Creates new instance.
ConstantFunction - Class in org.orekit.parameter
This class is used to define a constant parameterizable function.
ConstantFunction(Parameter) - Constructor for class org.orekit.parameter.ConstantFunction
Simple constructor with a given Parameter.
ConstantFunction(String, double) - Constructor for class org.orekit.parameter.ConstantFunction
Simple constructor with a given name and value.
ConstantFunction(double) - Constructor for class org.orekit.parameter.ConstantFunction
Simple constructor with a given name and value.
Constants - Interface in org.orekit.utils
Set of useful physical constants.
ConstantSolarActivity - Class in org.orekit.forces.atmospheres.solarActivity
This class represents constant solar activity
ConstantSolarActivity(double, double) - Constructor for class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Constructor for constant solar activity
ConstantSolarActivity(double, double, double) - Constructor for class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Constructor for constant solar activity
ConstantSpinSlew - Class in org.orekit.attitudes
This class extends the AbstractSlew.
ConstantSpinSlew(AttitudeProvider, AttitudeProvider, AbsoluteDate, AbsoluteDate) - Constructor for class org.orekit.attitudes.ConstantSpinSlew
Builds a ConstantSpinSlew based on a given interval of dates
ConstantSpinSlew(AttitudeProvider, AttitudeProvider, AbsoluteDate, boolean, double, ConstantSpinSlew.Constraint) - Constructor for class org.orekit.attitudes.ConstantSpinSlew
Builds a ConstantSpinSlew from a type of constraint and its value
ConstantSpinSlew.Constraint - Enum in org.orekit.attitudes
Enumeration of the existing constraint types
ConstantThrustError - Class in org.orekit.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 org.orekit.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 org.orekit.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
ConstantThrustError(AbsoluteDate, double, double, double, double, double, double, double, AbsoluteDate) - Constructor for class org.orekit.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
ConstantThrustError(AbsoluteDate, double, Parameter, Parameter, Parameter) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(AbsoluteDate, double, double, double, double) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(AbsoluteDate, double, Frame, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class org.orekit.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 org.orekit.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
ConstantThrustError(AbsoluteDate, double, Frame, double, double, double, double, double, double, AbsoluteDate) - Constructor for class org.orekit.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
ConstantThrustError(AbsoluteDate, double, Frame, Parameter, Parameter, Parameter) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(AbsoluteDate, double, Frame, double, double, double) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(AbsoluteDate, double, LOFType, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class org.orekit.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 org.orekit.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
ConstantThrustError(AbsoluteDate, double, LOFType, double, double, double, double, double, double, AbsoluteDate) - Constructor for class org.orekit.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
ConstantThrustError(AbsoluteDate, double, LOFType, Parameter, Parameter, Parameter) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(AbsoluteDate, double, LOFType, double, double, double) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(EventDetector, EventDetector, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(EventDetector, EventDetector, Parameter, Parameter, Parameter) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(EventDetector, EventDetector, Frame, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(EventDetector, EventDetector, Frame, Parameter, Parameter, Parameter) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(EventDetector, EventDetector, LOFType, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustError(EventDetector, EventDetector, LOFType, Parameter, Parameter, Parameter) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustError
Create a constant thrust error model whose x, y and z components are constant functions:
fx = cx
fy = cy
fz = cz
ConstantThrustManeuver - Class in org.orekit.forces.maneuvers
This class implements a simple maneuver with constant thrust.
ConstantThrustManeuver(AbsoluteDate, double, double, double, Vector3D, MassProvider, String) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustManeuver
Constructor for a constant direction in satellite frame and constant thrust.
ConstantThrustManeuver(AbsoluteDate, double, double, double, Vector3D, MassProvider, String, Frame) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustManeuver
Constructor for a constant direction in provided frame and constant thrust.
ConstantThrustManeuver(AbsoluteDate, double, double, double, Vector3D, MassProvider, String, LOFType) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustManeuver
Constructor for a constant direction in provided local orbital frame and constant thrust.
ConstantThrustManeuver(AbsoluteDate, double, Parameter, Parameter, Vector3D, MassProvider, String) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustManeuver
Constructor for a constant direction in satellite frame and constant thrust using Parameter.
ConstantThrustManeuver(AbsoluteDate, double, Parameter, Parameter, Vector3D, MassProvider, String, Frame) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustManeuver
Constructor for a constant direction in provided frame and constant thrust using Parameter.
ConstantThrustManeuver(AbsoluteDate, double, Parameter, Parameter, Vector3D, MassProvider, String, LOFType) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustManeuver
Constructor for a constant direction in provided local orbital frame and constant thrust using Parameter with a local orbital frame defined by its type.
ConstantThrustManeuver(EventDetector, EventDetector, double, double, Vector3D, MassProvider, String) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustManeuver
Constructor for a constant direction in satellite frame and constant thrust.
ConstantThrustManeuver(EventDetector, EventDetector, double, double, Vector3D, MassProvider, String, Frame) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustManeuver
Constructor for a constant direction in provided frame and constant thrust.
ConstantThrustManeuver(EventDetector, EventDetector, double, double, Vector3D, MassProvider, String, LOFType) - Constructor for class org.orekit.forces.maneuvers.ConstantThrustManeuver
Constructor for a constant direction in provided local orbital frame and constant thrust.
ConstantVectorDirection - Class in org.orekit.attitudes.directions
Direction described only by a vector constant in a frame
ConstantVectorDirection(Vector3D, Frame) - Constructor for class org.orekit.attitudes.directions.ConstantVectorDirection
Build a direction from a frame and a vector constant in this frame
contains(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Check if the instance contains a point.
contains(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Check if the instance contains a point.
contains(Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Check if the line contains a point.
contains(Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check if the instance entirely contains another region.
contains(Region<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check if the instance entirely contains another region.
contains(Comparable<T>) - Method in class org.orekit.utils.ComparableInterval
Returns true when the value belongs to the interval.
containsClass(Class<?>) - Method in class org.apache.commons.math3.util.TransformerMap
Tests if a Class is present in the TransformerMap.
containsKey(int) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Check if a value is associated with a key.
containsKey(int) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Check if a value is associated with a key.
containsSatellite(String) - Method in interface org.orekit.files.general.OrbitFile
Tests whether a satellite with the given id is contained in this orbit file.
containsSatellite(String) - Method in class org.orekit.files.sp3.SP3File
Tests whether a satellite with the given id is contained in this orbit file.
containsTransformer(NumberTransformer) - Method in class org.apache.commons.math3.util.TransformerMap
Tests if a NumberTransformer is present in the TransformerMap.
ContinuedFraction - Class in org.apache.commons.math3.util
Provides a generic means to evaluate continued fractions.
ContinuedFraction() - Constructor for class org.apache.commons.math3.util.ContinuedFraction
Default constructor.
ContinuousMSISE2000SolarData - Class in org.orekit.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 org.orekit.forces.atmospheres.solarActivity.specialized.ContinuousMSISE2000SolarData
Constructor.
ContinuousOutputModel - Class in org.apache.commons.math3.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 org.apache.commons.math3.ode.ContinuousOutputModel
Simple constructor.
contract() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Contracts the storage array to the (size of the element set) + 1 - to avoid a zero length array.
convention - Variable in class org.apache.commons.math3.utils.AbstractSearchIndex
The convention for the definition of intervals.
converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optim.AbstractConvergenceChecker
Check if the optimization algorithm has converged.
converged(int, PAIR, PAIR) - Method in interface org.apache.commons.math3.optim.ConvergenceChecker
Check if the optimization algorithm has converged.
converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optim.SimplePointChecker
Check if the optimization algorithm has converged considering the last two points.
converged(int, PointValuePair, PointValuePair) - Method in class org.apache.commons.math3.optim.SimpleValueChecker
Check if the optimization algorithm has converged considering the last two points.
converged(int, PointVectorValuePair, PointVectorValuePair) - Method in class org.apache.commons.math3.optim.SimpleVectorValueChecker
Check if the optimization algorithm has converged considering the last two points.
converged(int, UnivariatePointValuePair, UnivariatePointValuePair) - Method in class org.apache.commons.math3.optim.univariate.SimpleUnivariateValueChecker
Check if the optimization algorithm has converged considering the last two points.
converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated. Check if the optimization algorithm has converged.
converged(int, PAIR, PAIR) - Method in interface org.apache.commons.math3.optimization.ConvergenceChecker
Deprecated. Check if the optimization algorithm has converged.
converged(int, PAIR, PAIR) - Method in class org.apache.commons.math3.optimization.SimplePointChecker
Deprecated. Check if the optimization algorithm has converged considering the last two points.
converged(int, PointValuePair, PointValuePair) - Method in class org.apache.commons.math3.optimization.SimpleValueChecker
Deprecated. Check if the optimization algorithm has converged considering the last two points.
converged(int, PointVectorValuePair, PointVectorValuePair) - Method in class org.apache.commons.math3.optimization.SimpleVectorValueChecker
Deprecated. Check if the optimization algorithm has converged considering the last two points.
converged(int, UnivariatePointValuePair, UnivariatePointValuePair) - Method in class org.apache.commons.math3.optimization.univariate.SimpleUnivariateValueChecker
Deprecated. Check if the optimization algorithm has converged considering the last two points.
ConvergenceChecker<PAIR> - Interface in org.apache.commons.math3.optim
This interface specifies how to check if an optimization algorithm has converged.
ConvergenceChecker<PAIR> - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
ConvergenceException - Exception in org.apache.commons.math3.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 org.apache.commons.math3.exception.ConvergenceException
Construct the exception.
ConvergenceException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.ConvergenceException
Construct the exception with a specific context and arguments.
convert() - Method in class org.orekit.propagation.OsculatingToMeanElementsConverter
Convert an osculating orbit into a mean orbit, in DSST sense.
convertFrame(Orbit, Frame) - Method in class org.orekit.propagation.analytical.AbstractLyddanePropagator
Convert provided orbit in output frame.
convertOrbit(Orbit, Frame) - Method in enum org.orekit.orbits.OrbitType
Convert an orbit from a given orbit type to an other in a wished frame.
convertTab(SpacecraftState[], int) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
Convert the SpacecraftState[] into a double[] which represents the duration from the first state date.
convertToComplex(double[]) - Static method in class org.apache.commons.math3.complex.ComplexUtils
Convert an array of primitive doubles to an array of Complex objects.
convertType(Orbit) - Method in enum org.orekit.orbits.OrbitType
Convert an orbit to the instance type.
copy() - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
Copy this.
copy() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Make a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Make a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns a (deep) copy of this vector.
copy() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Make a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns a (deep) copy of this.
copy() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Make a (deep) copy of this.
copy() - Method in interface org.apache.commons.math3.linear.FieldVector
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Returns a (deep) copy of this vector.
copy() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.RealVector
Returns a (deep) copy of this vector.
copy() - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Make a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Copy the instance.
copy() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Copy the instance.
copy() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns a copy of this DescriptiveStatistics instance with the same internal state.
copy(DescriptiveStatistics, DescriptiveStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns a copy of the statistic with the same internal state.
copy(GeometricMean, GeometricMean) - Static method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Returns a copy of the statistic with the same internal state.
copy(Kurtosis, Kurtosis) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns a copy of the statistic with the same internal state.
copy(Mean, Mean) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Returns a copy of the statistic with the same internal state.
copy(SecondMoment, SecondMoment) - Static method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns a copy of the statistic with the same internal state.
copy(SemiVariance, SemiVariance) - Static method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Returns a copy of the statistic with the same internal state.
copy(Skewness, Skewness) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns a copy of the statistic with the same internal state.
copy(StandardDeviation, StandardDeviation) - Static method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns a copy of the statistic with the same internal state.
copy(Variance, Variance) - Static method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Returns a copy of the statistic with the same internal state.
copy(Max, Max) - Static method in class org.apache.commons.math3.stat.descriptive.rank.Max
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Returns a copy of the statistic with the same internal state.
copy(Min, Min) - Static method in class org.apache.commons.math3.stat.descriptive.rank.Min
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns a copy of the statistic with the same internal state.
copy(Percentile, Percentile) - Static method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Copies source to dest.
copy() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns a copy of the statistic with the same internal state.
copy(Product, Product) - Static method in class org.apache.commons.math3.stat.descriptive.summary.Product
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Returns a copy of the statistic with the same internal state.
copy(Sum, Sum) - Static method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Returns a copy of the statistic with the same internal state.
copy(SumOfLogs, SumOfLogs) - Static method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Returns a copy of the statistic with the same internal state.
copy(SumOfSquares, SumOfSquares) - Static method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns a copy of this SummaryStatistics instance with the same internal state.
copy(SummaryStatistics, SummaryStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns a copy of this SynchronizedDescriptiveStatistics instance with the same internal state.
copy(SynchronizedDescriptiveStatistics, SynchronizedDescriptiveStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Copies source to dest.
copy() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns a copy of this SynchronizedSummaryStatistics instance with the same internal state.
copy(SynchronizedSummaryStatistics, SynchronizedSummaryStatistics) - Static method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Copies source to dest.
copy() - Method in interface org.apache.commons.math3.stat.descriptive.UnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy(ResizableDoubleArray, ResizableDoubleArray) - Static method in class org.apache.commons.math3.util.ResizableDoubleArray
Copies source to dest, copying the underlying data, so dest is a new, independent copy of source.
copy() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns a copy of the ResizableDoubleArray.
copy() - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Copy this.
copyOf(int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates a copy of the source array.
copyOf(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates a copy of the source array.
copyOf(int[], int) - Static method in class org.apache.commons.math3.util.MathArrays
Creates a copy of the source array.
copyOf(double[], int) - Static method in class org.apache.commons.math3.util.MathArrays
Creates a copy of the source array.
copySelf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Copy the instance.
copySelf() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Copy the instance.
copySelf() - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Copy the instance.
copySelf() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Copy the instance.
copySelf() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Copy the instance.
copySign(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the instance with the sign of the argument.
copySign(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the instance with the sign of the argument.
copysign(Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.Dfp
Creates an instance that is the same as x except that it has the sign of y.
copySign(T) - Method in interface org.apache.commons.math3.RealFieldElement
Returns the instance with the sign of the argument.
copySign(double) - Method in interface org.apache.commons.math3.RealFieldElement
Returns the instance with the sign of the argument.
copySign(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Returns the first argument with the sign of the second argument.
copySign(float, float) - Static method in class org.apache.commons.math3.util.FastMath
Returns the first argument with the sign of the second argument.
copySign(byte, byte) - Static method in class org.apache.commons.math3.util.MathUtils
Returns the first argument with the sign of the second argument.
copySign(short, short) - Static method in class org.apache.commons.math3.util.MathUtils
Returns the first argument with the sign of the second argument.
copySign(int, int) - Static method in class org.apache.commons.math3.util.MathUtils
Returns the first argument with the sign of the second argument.
copySign(long, long) - Static method in class org.apache.commons.math3.util.MathUtils
Returns the first argument with the sign of the second argument.
copySubMatrix(int, int, int, int, T[][]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Copy a submatrix.
copySubMatrix(int[], int[], T[][]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Copy a submatrix.
copySubMatrix(int, int, int, int, double[][]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Copy a submatrix.
copySubMatrix(int[], int[], double[][]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Copy a submatrix.
copySubMatrix(int, int, int, int, T[][]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Copy a submatrix.
copySubMatrix(int[], int[], T[][]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Copy a submatrix.
copySubMatrix(int, int, int, int, double[][]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Copy a submatrix.
copySubMatrix(int[], int[], double[][]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Copy a submatrix.
CoriolisRelativisticEffect - Class in org.orekit.forces.relativistic
Computation of the relativistic Coriolis effect (Einstein-de-Sitter effect) - IERS2003 standard (applies to Earth only).
CoriolisRelativisticEffect(double, PVCoordinatesProvider) - Constructor for class org.orekit.forces.relativistic.CoriolisRelativisticEffect
Constructor with partial derivative computation by default.
CoriolisRelativisticEffect(double, PVCoordinatesProvider, boolean) - Constructor for class org.orekit.forces.relativistic.CoriolisRelativisticEffect
Constructor.
correct(double[]) - Method in class org.apache.commons.math3.filter.KalmanFilter
Correct the current state estimate with an actual measurement.
correct(RealVector) - Method in class org.apache.commons.math3.filter.KalmanFilter
Correct the current state estimate with an actual measurement.
correctInclination(double, double) - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Deprecated. 
correctInclination(double, double) - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Inclination correction because of inclination singularity in StelaEquinoctial parameters around 180deg.
CorrelatedRandomVectorGenerator - Class in org.apache.commons.math3.random
A RandomVectorGenerator that generates vectors with with correlated components.
CorrelatedRandomVectorGenerator(double[], RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Builds a correlated random vector generator from its mean vector and covariance matrix.
CorrelatedRandomVectorGenerator(RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Builds a null mean random correlated vector generator from its covariance matrix.
correlation(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Computes the Pearson's product-moment correlation coefficient between the two arrays.
correlation(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Computes the Spearman's rank correlation coefficient between the two arrays.
cos() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Cosine operation.
cos(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute cosine of a derivative structure.
Cos - Class in org.apache.commons.math3.analysis.function
Cosine function.
Cos() - Constructor for class org.apache.commons.math3.analysis.function.Cos
 
cos() - Method in class org.apache.commons.math3.complex.Complex
Compute the cosine of this complex number.
cos(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the cosine of the argument.
cos() - Method in interface org.apache.commons.math3.RealFieldElement
Cosine operation.
cos(double) - Static method in class org.apache.commons.math3.util.FastMath
Cosine function.
cosh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Hyperbolic cosine operation.
cosh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute hyperbolic cosine of a derivative structure.
Cosh - Class in org.apache.commons.math3.analysis.function
Hyperbolic cosine function.
Cosh() - Constructor for class org.apache.commons.math3.analysis.function.Cosh
 
cosh() - Method in class org.apache.commons.math3.complex.Complex
Compute the hyperbolic cosine of this complex number.
cosh() - Method in interface org.apache.commons.math3.RealFieldElement
Hyperbolic cosine operation.
cosh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the hyperbolic cosine of a number.
cosi0 - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
cosinus original inclination.
cosine(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Computes the cosine of the angle between this vector and the argument.
cosInternal(Dfp[]) - Static method in class org.apache.commons.math3.dfp.DfpMath
Computes cos(a) Used when 0 < a < pi/4.
cost - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1. Field to become "private" in 4.0. Please use AbstractLeastSquaresOptimizer.setCost(double).
Covariance - Class in org.apache.commons.math3.stat.correlation
Computes covariances for pairs of arrays or columns of a matrix.
Covariance() - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a Covariance with no data
Covariance(double[][], boolean) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a Covariance matrix from a rectangular array whose columns represent covariates.
Covariance(double[][]) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a Covariance matrix from a rectangular array whose columns represent covariates.
Covariance(RealMatrix, boolean) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a covariance matrix from a matrix whose columns represent covariates.
Covariance(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.Covariance
Create a covariance matrix from a matrix whose columns represent covariates.
covariance(double[], double[], boolean) - Method in class org.apache.commons.math3.stat.correlation.Covariance
Computes the covariance between the two arrays.
covariance(double[], double[]) - Method in class org.apache.commons.math3.stat.correlation.Covariance
Computes the covariance between the two arrays, using the bias-corrected formula.
CovarianceInterpolation - Class in org.orekit.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 org.orekit.propagation.analytical.covariance.CovarianceInterpolation
Constructor of the class CovarianceInterpolation
CovarianceInterpolation(AbsoluteDate, double[][], AbsoluteDate, double[][], int, Orbit, double) - Constructor for class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
Constructor of the class CovarianceInterpolation
covarianceToCorrelation(RealMatrix) - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Derives a correlation matrix from a covariance matrix.
create(RealLinearOperator) - Static method in class org.apache.commons.math3.linear.JacobiPreconditioner
Creates a new instance of this class.
createAdaptor(RandomGenerator) - Static method in class org.apache.commons.math3.random.RandomAdaptor
Factory method to create a Random using the supplied RandomGenerator.
createBlocksLayout(Field<T>, int, int) - Static method in class org.apache.commons.math3.linear.BlockFieldMatrix
Create a data array in blocks layout.
createBlocksLayout(int, int) - Static method in class org.apache.commons.math3.linear.BlockRealMatrix
Create a data array in blocks layout.
createChebyshevPolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Chebyshev polynomial of the first kind.
createColumnFieldMatrix(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Creates a column FieldMatrix using the data from the input array.
createColumnRealMatrix(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Creates a column RealMatrix using the data from the input array.
createComplex(double, double) - Method in class org.apache.commons.math3.complex.Complex
Create a complex number given the real and imaginary parts.
createComplexArray(double[][]) - Static method in class org.apache.commons.math3.transform.TransformUtils
Builds a new array of Complex from the specified two dimensional array of real and imaginary parts.
createConstant(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Create a constant compatible with instance order and number of parameters.
createContributingStatistics() - Method in class org.apache.commons.math3.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 org.orekit.propagation.analytical.covariance.CovarianceInterpolation
Creates a diagonal square matrix of dimension dim equals to coef * identity (dim)
createDiagonalMatrix(int, double) - Static method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
Creates a diagonal square matrix of dimension dim equals to coef * identity (dim)
createDiagonalMatrixWithArray(int, int, double[]) - Static method in class org.apache.commons.math3.linear.SymmetricMatrix
Creates an instance of SymmetricMatrix which is diagonal of input element.
createFieldDiagonalMatrix(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a diagonal matrix with specified elements.
createFieldIdentityMatrix(Field<T>, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns dimension x dimension identity matrix.
createFieldMatrix(Field<T>, int, int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a FieldMatrix with specified dimensions.
createFieldMatrix(T[][]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a FieldMatrix whose entries are the the values in the the input array.
createFieldVector(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Creates a FieldVector using the data from the input array.
createFromModifiedRodrigues(double[][], boolean) - Static method in class org.orekit.utils.AngularCoordinates
Convert a modified Rodrigues vector and derivatives to angular coordinates.
createFromModifiedRodrigues(double[][]) - Static method in class org.orekit.utils.AngularCoordinates
Convert a modified Rodrigues vector and derivatives to angular coordinates.
createFromWeekComponents(int, int, int) - Static method in class org.orekit.time.DateComponents
Build a date from week components.
createGPSDate(int, double) - Static method in class org.orekit.time.AbsoluteDate
Build an instance corresponding to a GPS date.
createHermitePolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Hermite polynomial.
createIllegalArgumentException(Localizable, Object...) - Static method in exception org.orekit.errors.OrekitException
Create an IllegalArgumentException with localized message.
createIllegalStateException(Localizable, Object...) - Static method in exception org.orekit.errors.OrekitException
Create an IllegalStateException with localized message.
createInternalError(Throwable) - Static method in exception org.orekit.errors.OrekitException
Create an RuntimeException for an internal error.
createInverseJacobian(PositionAngle) - Method in class org.orekit.orbits.Orbit
Create an inverse Jacobian.
createJacobiPolynomial(int, int, int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Jacobi polynomial.
createLaguerrePolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Laguerre polynomial.
createLegendrePolynomial(int) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialsUtils
Create a Legendre polynomial.
createLine(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Creates a Line object from a point of space and a direction vector.
createMatrix(int, int) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.linear.AbstractRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.linear.Array2DRowRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.linear.BlockRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in interface org.apache.commons.math3.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 class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createObjectListFromData(Data<Double>, DataType) - Static method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.DeviationProviderFactory
Transforms a list of columns of double precision values into a list of meaningful objects.
createParseException(Localizable, Object...) - Static method in exception org.orekit.errors.OrekitException
Create an ParseException with localized message.
createRealDiagonalMatrix(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a diagonal matrix with specified elements.
createRealIdentityMatrix(int) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns dimension x dimension identity matrix.
createRealImaginaryArray(Complex[]) - Static method in class org.apache.commons.math3.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 org.apache.commons.math3.linear.MatrixUtils
Returns a RealMatrix with specified dimensions.
createRealMatrix(double[][]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Returns a RealMatrix whose entries are the the values in the the input array.
createRealVector(double[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Creates a RealVector using the data from the input array.
createReport(BufferedWriter, List<String>, TreeMap<String, ArrayList<Double>>, double) - Static method in class fr.cnes.sirius.patrius.tools.force.validation.Report
Method to create the html report.
createRowFieldMatrix(T[]) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Create a row FieldMatrix using the data from the input array.
createRowRealMatrix(double[]) - Static method in class org.apache.commons.math3.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.
createTable(BufferedWriter, String, int, int, List<String>, ArrayList<Double>, ArrayList<Double>, double, List<String>) - Static method in class fr.cnes.sirius.patrius.tools.force.validation.Report
Method to create a table.
CRITICAL_PROGRADE_INCLINATION - Static variable in interface org.orekit.utils.CnesConstants
Critical prograde inclination from 4 - 5 × sin2i = 0 see "Fundamentals of Astrodynamics and Applications", 3rd Edition, D.
CRITICAL_RETROGRADE_INCLINATION - Static variable in interface org.orekit.utils.CnesConstants
Critical retrograde inclination from 4 - 5 × sin2i = 0 see "Fundamentals of Astrodynamics and Applications", 3rd Edition, D.
crossover(Chromosome, Chromosome) - Method in interface org.apache.commons.math3.genetics.CrossoverPolicy
Perform a crossover operation on the given chromosomes.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.CycleCrossover
Perform a crossover operation on the given chromosomes.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.NPointCrossover
Performs a N-point crossover.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.OnePointCrossover
Performs one point crossover.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.OrderedCrossover
Perform a crossover operation on the given chromosomes.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math3.genetics.UniformCrossover
Perform a crossover operation on the given chromosomes.
CrossoverPolicy - Interface in org.apache.commons.math3.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 org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of the instance with another vector.
crossProduct(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of the instance with another vector.
crossProduct(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of two vectors.
crossProduct(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of two vectors.
crossProduct(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the cross-product of two vectors.
crossProduct(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the cross-product of the instance with another vector.
crossProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the cross-product of two vectors.
crossProduct(PVCoordinates, PVCoordinates) - Static method in class org.orekit.utils.PVCoordinates
Compute the cross-product of two instances.
CrossProductDirection - Class in org.orekit.attitudes.directions
This direction is the cross product of two directions
CrossProductDirection(IDirection, IDirection) - Constructor for class org.orekit.attitudes.directions.CrossProductDirection
Build a cross product of two directions.
CrossSectionProvider - Interface in org.apache.commons.math3.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.
cumulativeProbability(int, int) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Deprecated. As of 3.1 (to be removed in 4.0). Please use AbstractRealDistribution.probability(double,double) instead.
cumulativeProbability(double) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.distribution.LogNormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Deprecated. See RealDistribution.cumulativeProbability(double,double)
cumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double, double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
Deprecated. See RealDistribution.cumulativeProbability(double,double)
cumulativeProbability(int) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.distribution.RealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
cumulativeProbability(double, double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Deprecated. As of 3.1. In 4.0, this method will be renamed probability(double x0, double x1).
cumulativeProbability(double) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.random.EmpiricalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X <= x).
CunninghamAttractionModel - Class in org.orekit.forces.gravity
This class represents the gravitational field of a celestial body.
CunninghamAttractionModel(Frame, double, double, double[][], double[][]) - Constructor for class org.orekit.forces.gravity.CunninghamAttractionModel
Creates a new instance.
CunninghamAttractionModel(Frame, double, double, double[][], double[][], int, int) - Constructor for class org.orekit.forces.gravity.CunninghamAttractionModel
Creates a new instance.
CunninghamAttractionModel(Frame, Parameter, Parameter, double[][], double[][]) - Constructor for class org.orekit.forces.gravity.CunninghamAttractionModel
Creates a new instance using Parameter.
CunninghamAttractionModel(Frame, Parameter, Parameter, double[][], double[][], int, int) - Constructor for class org.orekit.forces.gravity.CunninghamAttractionModel
Creates a new instance using Parameter.
currentProvider - Variable in class org.orekit.attitudes.AbstractSlew
The PV coordinates provider that has been used to compute the maneuver.
currentState - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
current state
CurveFitter<T extends ParametricUnivariateFunction> - Class in org.apache.commons.math3.fitting
Fitter for parametric univariate real functions y = f(x).
CurveFitter(MultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.fitting.CurveFitter
Simple constructor.
CurveFitter<T extends ParametricUnivariateFunction> - Class in org.apache.commons.math3.optimization.fitting
Deprecated. As of 3.1 (to be removed in 4.0).
CurveFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated. as of 3.1 replaced by CurveFitter.CurveFitter(MultivariateDifferentiableVectorOptimizer)
CurveFitter(MultivariateDifferentiableVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated. 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 org.apache.commons.math3.genetics
Cycle Crossover [CX] builds offspring from ordered chromosomes by identifying cycles between two parent chromosomes.
CycleCrossover() - Constructor for class org.apache.commons.math3.genetics.CycleCrossover
Creates a new CycleCrossover policy.
CycleCrossover(boolean) - Constructor for class org.apache.commons.math3.genetics.CycleCrossover
Creates a new CycleCrossover policy using the given randomStart behavior.
Cylinder - Interface in org.apache.commons.math3.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.

D

D0 - Static variable in class org.orekit.forces.radiation.KnockeRiesModel
coefficient a0 of Knocke-Ries model.
Data<T> - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class represents a set of columns, which values are Ts.
Data(ArrayList<ArrayList<T>>) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.Data
this constructor initialises the columns
data - Variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Solar data container
DataComparator<T> - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
Parent to the data comparators, this class provides the main computeComparison function.
DataComparator() - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.DataComparator
 
DataLoader - Interface in org.orekit.data
Interface for loading data files from data providers.
DataProvider - Interface in org.orekit.data
Interface for providing data files to file loaders.
DataProvidersManager - Class in org.orekit.data
Singleton class managing all supported data providers.
DataType - Enum in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class enumerates the available data types.
DateComponents - Class in org.orekit.time
Class representing a date broken up as year, month and day components.
DateComponents(int, int, int) - Constructor for class org.orekit.time.DateComponents
Build a date from its components.
DateComponents(int, Month, int) - Constructor for class org.orekit.time.DateComponents
Build a date from its components.
DateComponents(int, int) - Constructor for class org.orekit.time.DateComponents
Build a date from a year and day number.
DateComponents(int) - Constructor for class org.orekit.time.DateComponents
Build a date from its offset with respect to a DateComponents.J2000_EPOCH.
DateComponents(DateComponents, int) - Constructor for class org.orekit.time.DateComponents
Build a date from its offset with respect to a reference epoch.
DateDetector - Class in org.orekit.propagation.events
Finder for date events.
DateDetector(double, double) - Constructor for class org.orekit.propagation.events.DateDetector
Build a new instance.
DateDetector(double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.DateDetector
Build a new instance.
DateDetector(double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.DateDetector
Build a new instance.
DateDetector(AbsoluteDate, double, double) - Constructor for class org.orekit.propagation.events.DateDetector
Build a new instance.
DateDetector(AbsoluteDate, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.DateDetector
Build a new instance.
DateDetector(AbsoluteDate, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.DateDetector
Build a new instance.
DateDetector(AbsoluteDate) - Constructor for class org.orekit.propagation.events.DateDetector
Build a new instance.
DateDPFacade - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class is a facade for the use of dates.
DateIntervalLinearFunction - Class in org.orekit.propagation.analytical.twod
This class represents a piecewise linear function of date.
The function is defined by an initial condition x0 at a date t[0] and all first derivatives xDot[i] on intervals [t[i],t[i+1]].
DateIntervalLinearFunction(double, AbsoluteDate[], double[]) - Constructor for class org.orekit.propagation.analytical.twod.DateIntervalLinearFunction
Constructor.
DateIntervalLinearFunction(DateIntervalLinearFunction) - Constructor for class org.orekit.propagation.analytical.twod.DateIntervalLinearFunction
Clone constructor.
DateIntervalParabolicFunction - Class in org.orekit.propagation.analytical.twod
This class represents a piecewise 2nd order polynomial function of date.
The function is defined by an initial condition (x0, xDot0) at a date t[0] and all second derivatives xDotDot[i] on intervals [t[i],t[i+1]].
DateIntervalParabolicFunction(double, double, AbsoluteDate[], double[]) - Constructor for class org.orekit.propagation.analytical.twod.DateIntervalParabolicFunction
Constructor.
DateIntervalParabolicFunction(DateIntervalParabolicFunction) - Constructor for class org.orekit.propagation.analytical.twod.DateIntervalParabolicFunction
Clone constructor.
DatePolynomialFunction - Class in org.orekit.propagation.analytical.twod
This class represents a polynomial function of date.
DatePolynomialFunction(AbsoluteDate, double[]) - Constructor for class org.orekit.propagation.analytical.twod.DatePolynomialFunction
Constructor.
DatePolynomialFunction(DatePolynomialFunction) - Constructor for class org.orekit.propagation.analytical.twod.DatePolynomialFunction
Clone constructor.
DateTimeComponents - Class in org.orekit.time
Holder for date and time components.
DateTimeComponents(DateComponents, TimeComponents) - Constructor for class org.orekit.time.DateTimeComponents
Build a new instance from its components.
DateTimeComponents(int, int, int, int, int, double) - Constructor for class org.orekit.time.DateTimeComponents
Build an instance from raw level components.
DateTimeComponents(int, Month, int, int, int, double) - Constructor for class org.orekit.time.DateTimeComponents
Build an instance from raw level components.
DateTimeComponents(int, int, int) - Constructor for class org.orekit.time.DateTimeComponents
Build an instance from raw level components.
DateTimeComponents(int, Month, int) - Constructor for class org.orekit.time.DateTimeComponents
Build an instance from raw level components.
DateTimeComponents(DateTimeComponents, double) - Constructor for class org.orekit.time.DateTimeComponents
Build an instance from a seconds offset with respect to another one.
DAYSYEAR - Static variable in class org.orekit.forces.radiation.KnockeRiesModel
duration of a year (in days).
DBSCANClusterer<T extends Clusterable<T>> - Class in org.apache.commons.math3.stat.clustering
DBSCAN (density-based spatial clustering of applications with noise) algorithm.
DBSCANClusterer(double, int) - Constructor for class org.apache.commons.math3.stat.clustering.DBSCANClusterer
Creates a new instance of a DBSCANClusterer.
DctNormalization - Enum in org.apache.commons.math3.transform
This enumeration defines the various types of normalizations that can be applied to discrete cosine transforms (DCT).
Decimal64 - Class in org.apache.commons.math3.util
This class wraps a double value in an object.
Decimal64(double) - Constructor for class org.apache.commons.math3.util.Decimal64
Creates a new instance of this class.
Decimal64Field - Class in org.apache.commons.math3.util
The field of double precision floating-point numbers.
decode(List<T>) - Method in interface org.apache.commons.math3.genetics.PermutationChromosome
Permutes the sequence of objects of type T according to the permutation this chromosome represents.
decode(List<T>) - Method in class org.apache.commons.math3.genetics.RandomKey
Permutes the sequence of objects of type T according to the permutation this chromosome represents.
decompose() - Method in class org.apache.commons.math3.analysis.polynomials.FourierDecompositionEngine
Decompose function f, using user given period t and integrator, into a Fourier Series of order order.
DecompositionSolver - Interface in org.apache.commons.math3.linear
Interface handling decomposition algorithms that can solve A × X = B.
DECREASING - Static variable in interface org.apache.commons.math3.ode.events.EventHandler
Decreasing g-function related events parameter.
DECREASING - Static variable in interface org.orekit.propagation.events.EventDetector
Decreasing g-function related events parameter.
DECREASING - Static variable in interface org.orekit.propagation.events.multi.MultiEventDetector
Decreasing g-function related events parameter.
DEFAULT - Static variable in class org.orekit.propagation.analytical.tle.TLE
Identifier for default type of ephemeris (SGP4/SDP4).
DEFAULT_4HZ - Static variable in class org.orekit.attitudes.kinematics.KinematicsToolkit
Default 4 Hz integration step.
DEFAULT_8HZ - Static variable in class org.orekit.attitudes.kinematics.KinematicsToolkit
Default 8 Hz integration step.
DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Default absolute accuracy.
DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Default absolute accuracy.
DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.solvers.SecantSolver
Default absolute accuracy.
DEFAULT_ABSOLUTE_POSITIVITY_THRESHOLD - Static variable in class org.apache.commons.math3.linear.CholeskyDecomposition
Default threshold below which diagonal elements are considered null and matrix not positive definite.
DEFAULT_ABSOLUTE_POSITIVITY_THRESHOLD - Static variable in class org.apache.commons.math3.linear.UDDecompositionImpl
Default threshold below which diagonal elements are considered null and matrix not positive definite.
DEFAULT_ACCURACY - Static variable in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Default value for accuracy.
DEFAULT_BANDWIDTH - Static variable in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Default value of the bandwidth parameter.
DEFAULT_BIN_COUNT - Static variable in class org.apache.commons.math3.random.EmpiricalDistribution
Default bin count
DEFAULT_BRIGHTNESS_EXPONENT - Static variable in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Default exponent used the weights calculation.
DEFAULT_C_N - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
Default normal force coefficient value.
DEFAULT_C_T - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
Default tangential force coefficient value.
DEFAULT_C_X - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Default normal force coefficient value.
DEFAULT_CACHED_SLOTS_NUMBER - Static variable in class org.orekit.utils.TimeStampedCache
Default number of independent cached time slots.
DEFAULT_CHECKFEASABLECOUNT - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. Default value for CMAESOptimizer.checkFeasableCount: 0.
DEFAULT_DE_SUPPORTED_NAMES - Static variable in class org.orekit.bodies.JPLEphemeridesLoader
Default supported files name pattern for JPL DE files.
DEFAULT_DIAGONALONLY - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. Default value for CMAESOptimizer.diagonalOnly: 0.
DEFAULT_EPSILON - Static variable in class org.apache.commons.math3.distribution.PoissonDistribution
Default convergence criterion.
DEFAULT_EXTEND - Static variable in class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
Default number of extension points of the samples array.
DEFAULT_FORMAT - Static variable in class org.apache.commons.math3.linear.MatrixUtils
The default format for RealMatrix objects.
DEFAULT_INITIAL_RADIUS - Static variable in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
Default value for BOBYQAOptimizer.initialTrustRegionRadius: 10.0 .
DEFAULT_INITIAL_RADIUS - Static variable in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated. Default value for BOBYQAOptimizer.initialTrustRegionRadius: 10.0 .
DEFAULT_INPOP_SUPPORTED_NAMES - Static variable in class org.orekit.bodies.JPLEphemeridesLoader
Default supported files name pattern for IMCCE INPOP files.
DEFAULT_INTERP_ORDER - Static variable in class org.orekit.attitudes.TabulatedAttitude
Default number of points used for interpolation.
DEFAULT_INTERPOLATION_ORDER - Static variable in class org.orekit.propagation.precomputed.AbstractEphemeris
Default number of interpolated points.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.BetaDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.CauchyDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.ExponentialDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.FDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.GammaDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.LogNormalDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.NormalDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.TDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.UniformRealDistribution
Default inverse cumulative probability accuracy.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.WeibullDistribution
Default inverse cumulative probability accuracy.
DEFAULT_ISACTIVECMA - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. Default value for CMAESOptimizer.isActiveCMA: true.
DEFAULT_MAX_ITERATION_COUNT - Static variable in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
Default maximal number of iterations in the event time search.
DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math3.distribution.PoissonDistribution
Default maximum number of iterations for cumulative probability calculations.
DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated. Default maximal number of iterations allowed.
DEFAULT_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Default maximal iteration count.
DEFAULT_MAXCHECK - Static variable in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
Default maximum checking interval (s).
DEFAULT_MAXCHECK - Static variable in class org.orekit.propagation.events.AbstractDetector
Default maximum checking interval (s).
DEFAULT_MAXITERATIONS - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. Default value for CMAESOptimizer.maxIterations: 30000.
DEFAULT_MICROSPHERE_ELEMENTS - Static variable in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Default number of surface elements that composes the microsphere.
DEFAULT_MIN_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Default minimal iteration count.
DEFAULT_NAN_STRATEGY - Static variable in class org.apache.commons.math3.stat.ranking.NaturalRanking
default NaN strategy
DEFAULT_PREFIX - Static variable in class org.apache.commons.math3.geometry.VectorFormat
The default prefix: "{".
DEFAULT_PRESSURE - Static variable in class org.orekit.propagation.events.ApparentElevationDetector
Default local pressure at viewpoint (Pa).
DEFAULT_PREVIOUS_INDEX - Static variable in class org.orekit.propagation.precomputed.AbstractEphemeris
Default previous index.
DEFAULT_QUADRATURE_POINTS - Static variable in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
Default quadrature points
DEFAULT_RANDOMGENERATOR - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. Default value for CMAESOptimizer.random.
DEFAULT_RELATIVE_ACCURACY - Static variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Default relative accuracy.
DEFAULT_RELATIVE_SYMMETRY_THRESHOLD - Static variable in class org.apache.commons.math3.linear.CholeskyDecomposition
Default threshold above which off-diagonal elements are considered too different and matrix not symmetric.
DEFAULT_RELATIVE_SYMMETRY_THRESHOLD - Static variable in class org.apache.commons.math3.linear.UDDecompositionImpl
Default threshold above which off-diagonal elements are considered too different and matrix not symmetric.
DEFAULT_ROBUSTNESS_ITERS - Static variable in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Default value of the number of robustness iterations.
DEFAULT_SECONDS_PRECISION - Static variable in class org.orekit.time.TimeComponents
Default digit number of the seconds fractional part.
DEFAULT_SEPARATOR - Static variable in class org.apache.commons.math3.geometry.VectorFormat
The default separator: ", ".
DEFAULT_STOPFITNESS - Static variable in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. Default value for CMAESOptimizer.stopFitness: 0.0.
DEFAULT_STOPPING_RADIUS - Static variable in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
Default value for BOBYQAOptimizer.stoppingTrustRegionRadius: 1.0E-8 .
DEFAULT_STOPPING_RADIUS - Static variable in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated. Default value for BOBYQAOptimizer.stoppingTrustRegionRadius: 1.0E-8 .
DEFAULT_SUFFIX - Static variable in class org.apache.commons.math3.geometry.VectorFormat
The default suffix: "}".
DEFAULT_TEMPERATURE - Static variable in class org.orekit.propagation.events.ApparentElevationDetector
Default local temperature at viewpoint (K).
DEFAULT_THRESHOLD - Static variable in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
Default convergence threshold (s).
DEFAULT_THRESHOLD - Static variable in class org.orekit.propagation.events.AbstractDetector
Default convergence threshold (s).
DEFAULT_TIES_STRATEGY - Static variable in class org.apache.commons.math3.stat.ranking.NaturalRanking
default ties strategy
DEFAULT_ZERO_TOLERANCE - Static variable in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Default Tolerance for having a value considered zero.
DefaultFieldMatrixChangingVisitor<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Default implementation of the FieldMatrixChangingVisitor interface.
DefaultFieldMatrixChangingVisitor(T) - Constructor for class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
Build a new instance.
DefaultFieldMatrixPreservingVisitor<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Default implementation of the FieldMatrixPreservingVisitor interface.
DefaultFieldMatrixPreservingVisitor(T) - Constructor for class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
Build a new instance.
DefaultIterativeLinearSolverEvent - Class in org.apache.commons.math3.linear
A default concrete implementation of the abstract class IterativeLinearSolverEvent.
DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, RealVector, double) - Constructor for class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Creates a new instance of this class.
DefaultIterativeLinearSolverEvent(Object, int, RealVector, RealVector, double) - Constructor for class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Creates a new instance of this class.
DefaultMeasurementModel - Class in org.apache.commons.math3.filter
Default implementation of a MeasurementModel for the use with a KalmanFilter.
DefaultMeasurementModel(double[][], double[][]) - Constructor for class org.apache.commons.math3.filter.DefaultMeasurementModel
Create a new MeasurementModel, taking double arrays as input parameters for the respective measurement matrix and noise.
DefaultMeasurementModel(RealMatrix, RealMatrix) - Constructor for class org.apache.commons.math3.filter.DefaultMeasurementModel
Create a new MeasurementModel, taking RealMatrix objects as input parameters for the respective measurement matrix and noise.
DefaultProcessModel - Class in org.apache.commons.math3.filter
Default implementation of a ProcessModel for the use with a KalmanFilter.
DefaultProcessModel(double[][], double[][], double[][], double[], double[][]) - Constructor for class org.apache.commons.math3.filter.DefaultProcessModel
Create a new ProcessModel, taking double arrays as input parameters.
DefaultProcessModel(double[][], double[][], double[][]) - Constructor for class org.apache.commons.math3.filter.DefaultProcessModel
Create a new ProcessModel, taking double arrays as input parameters.
DefaultProcessModel(RealMatrix, RealMatrix, RealMatrix, RealVector, RealMatrix) - Constructor for class org.apache.commons.math3.filter.DefaultProcessModel
Create a new ProcessModel, taking double arrays as input parameters.
DefaultRealMatrixChangingVisitor - Class in org.apache.commons.math3.linear
Default implementation of the RealMatrixChangingVisitor interface.
DefaultRealMatrixChangingVisitor() - Constructor for class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
 
DefaultRealMatrixPreservingVisitor - Class in org.apache.commons.math3.linear
Default implementation of the RealMatrixPreservingVisitor interface.
DefaultRealMatrixPreservingVisitor() - Constructor for class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
 
DefaultTransformer - Class in org.apache.commons.math3.util
A Default NumberTransformer for java.lang.Numbers and Numeric Strings.
DefaultTransformer() - Constructor for class org.apache.commons.math3.util.DefaultTransformer
 
DEG_TO_RAD - Static variable in class org.apache.commons.math3.util.MathUtils
π/180.
degree() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns the degree of the polynomial.
degree() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns the degree of the polynomial.
degree() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Returns the degree of the polynomial.
DelayCriterion - Class in fr.cnes.sirius.patrius.events.postprocessing
 
DelayCriterion(String, double) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.DelayCriterion
Constructor
DelayCriterion(String, double, String, String) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.DelayCriterion
Constructor
delete(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Delete an element from the tree.
delete() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
Delete the node from the tree.
deleteJQNUMReportFiles() - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
Deletes the report file directory.
deNormalize(double[][]) - Static method in class org.orekit.forces.gravity.GravityToolbox
Denormalize an array of coefficients.
density(double) - Method in class org.apache.commons.math3.distribution.BetaDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.FDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.GammaDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double[]) - Method in class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double[]) - Method in class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double[]) - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.TDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
density(double) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns the probability density function (PDF) of this distribution evaluated at the specified point x.
densm(double, double, double, double, int, double[], double[], double[], int, double[], double[], double[]) - Method in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
Calculate temperature and density profiles for lower atmosphere.
densu(double, double, double, double, double, double, Double[], double, double, int, double[], double[], double[]) - Method in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
Calculate temperature and density profiles for MSIS models.
derivative() - Method in interface org.apache.commons.math3.analysis.DifferentiableUnivariateFunction
Deprecated. Returns the derivative of the function
derivative() - Method in interface org.apache.commons.math3.analysis.DifferentiableUnivariateMatrixFunction
Deprecated. Returns the derivative of the function
derivative() - Method in interface org.apache.commons.math3.analysis.DifferentiableUnivariateVectorFunction
Deprecated. Returns the derivative of the function
derivative() - Method in class org.apache.commons.math3.analysis.function.Acos
Deprecated. as of 3.1, replaced by Acos.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Acosh
Deprecated. as of 3.1, replaced by Acosh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Asin
Deprecated. as of 3.1, replaced by Asin.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Asinh
Deprecated. as of 3.1, replaced by Asinh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Atan
Deprecated. as of 3.1, replaced by Atan.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Atanh
Deprecated. as of 3.1, replaced by Atanh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Cbrt
Deprecated. as of 3.1, replaced by Cbrt.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Constant
Deprecated. as of 3.1, replaced by Constant.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Cos
Deprecated. as of 3.1, replaced by Cos.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Cosh
Deprecated. as of 3.1, replaced by Cosh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Exp
Deprecated. as of 3.1, replaced by Exp.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Expm1
Deprecated. as of 3.1, replaced by Expm1.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Gaussian
Deprecated. as of 3.1, replaced by Gaussian.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator
Deprecated. as of 3.1, replaced by HarmonicOscillator.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Identity
Deprecated. as of 3.1, replaced by Identity.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Inverse
Deprecated. as of 3.1, replaced by Inverse.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Log
Deprecated. as of 3.1, replaced by Log.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Log10
Deprecated. as of 3.1, replaced by Log10.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Log1p
Deprecated. as of 3.1, replaced by Log1p.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Logistic
Deprecated. as of 3.1, replaced by Logistic.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Logit
Deprecated. as of 3.1, replaced by Logit.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Minus
Deprecated. as of 3.1, replaced by Minus.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Power
Deprecated. as of 3.1, replaced by Power.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sigmoid
Deprecated. as of 3.1, replaced by Sigmoid.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sin
Deprecated. as of 3.1, replaced by Sin.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sinc
Deprecated. as of 3.1, replaced by Sinc.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sinh
Deprecated. as of 3.1, replaced by Sinh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Sqrt
Deprecated. as of 3.1, replaced by Sqrt.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Tan
Deprecated. as of 3.1, replaced by Tan.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.function.Tanh
Deprecated. as of 3.1, replaced by Tanh.value(DerivativeStructure)
derivative() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Compute and return derivative of polynomial
derivative(int) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Compute and return nth derivative of polynomial
derivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns the derivative as a UnivariateFunction.
derivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get the derivative of the polynomial spline function.
derivative() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Compute and return derivative of polynomial
derivative(int) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Compute and return nth derivative of polynomial
derivative() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get first order derivative
derivative(int) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get nth order derivative
derivative() - Method in class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Compute the OrientationFunction representing the first derivative of the current orientation function components.
The differentiation is performed using a numerical differentiation method.
derivative() - Method in interface org.orekit.attitudes.kinematics.OrientationFunction
Compute the OrientationFunction representing the first derivative of the current orientation function components.
The derivation can be analytical or numerical, depending on the current orientation function.
derivative(double) - Method in class org.orekit.utils.HermiteInterpolator
Interpolate first derivative at a specified abscissa.
derivative() - Method in class org.orekit.utils.HermiteInterpolator
Returns the derivative of the function
DerivativeStructure - Class in org.apache.commons.math3.analysis.differentiation
Class representing both the value and the differentials of a function.
DerivativeStructure(int, int) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Build an instance with all values and derivatives set to 0.
DerivativeStructure(int, int, double) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Build an instance representing a constant value.
DerivativeStructure(int, int, int, double) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Build an instance representing a variable.
DerivativeStructure(double, DerivativeStructure, double, DerivativeStructure) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Linear combination constructor.
DerivativeStructure(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Linear combination constructor.
DerivativeStructure(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Linear combination constructor.
DerivativeStructure(int, int, double...) - Constructor for class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Build an instance from all its derivatives.
derivativeValue(int, double) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Return value at x of nth order derivative
derivativeValue(Parameter, SpacecraftState) - Method in class org.orekit.parameter.ConstantFunction
Compute the derivative value with respect to the input parameter.
derivativeValue(Parameter, SpacecraftState) - Method in interface org.orekit.parameter.IParamDiffFunction
Compute the derivative value with respect to the input parameter.
derivativeValue(Parameter, SpacecraftState) - Method in class org.orekit.parameter.LinearFunction
Compute the derivative value with respect to the input parameter.
derivativeValue(Parameter, SpacecraftState) - Method in class org.orekit.parameter.PiecewiseFunction
Compute the derivative value with respect to the input parameter.
DESCENDING - Static variable in class org.orekit.propagation.events.NodeDetector
Flag for descending node detection (slopeSelection = 1).
DescriptiveStatistics - Class in org.apache.commons.math3.stat.descriptive
Maintains a dataset of values of a single variable and computes descriptive statistics based on stored data.
DescriptiveStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with an infinite window
DescriptiveStatistics(int) - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with the specified window
DescriptiveStatistics(double[]) - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with an infinite window and the initial data values in double[] initialDoubleArray.
DescriptiveStatistics(DescriptiveStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Copy constructor.
deserializeRealMatrix(Object, String, ObjectInputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Deserialize a RealMatrix field in a class.
deserializeRealVector(Object, String, ObjectInputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Deserialize a RealVector field in a class.
DeviationProvider - Interface in fr.cnes.sirius.patrius.tools.ephemerisComparator
This interface specify one method, the computation of a deviation.
DeviationProviderFactory - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This is a factory to simplify the construction of DeviationProvider objects.
df(double, double, double, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes approximate degrees of freedom for 2-sample t-test.
Dfp - Class in org.apache.commons.math3.dfp
Decimal floating point library for Java
Dfp(DfpField) - Constructor for class org.apache.commons.math3.dfp.Dfp
Makes an instance with a value of zero.
Dfp(DfpField, byte) - Constructor for class org.apache.commons.math3.dfp.Dfp
Create an instance from a byte value.
Dfp(DfpField, int) - Constructor for class org.apache.commons.math3.dfp.Dfp
Create an instance from an int value.
Dfp(DfpField, long) - Constructor for class org.apache.commons.math3.dfp.Dfp
Create an instance from a long value.
Dfp(DfpField, double) - Constructor for class org.apache.commons.math3.dfp.Dfp
Create an instance from a double value.
Dfp(Dfp) - Constructor for class org.apache.commons.math3.dfp.Dfp
Copy constructor.
Dfp(DfpField, String) - Constructor for class org.apache.commons.math3.dfp.Dfp
Create an instance from a String representation.
Dfp(DfpField, byte, byte) - Constructor for class org.apache.commons.math3.dfp.Dfp
Creates an instance with a non-finite value.
dfp2sci() - Method in class org.apache.commons.math3.dfp.Dfp
Convert an instance to a string using scientific notation.
dfp2string() - Method in class org.apache.commons.math3.dfp.Dfp
Convert an instance to a string using normal notation.
DfpDec - Class in org.apache.commons.math3.dfp
Subclass of Dfp which hides the radix-10000 artifacts of the superclass.
DfpDec(DfpField) - Constructor for class org.apache.commons.math3.dfp.DfpDec
Makes an instance with a value of zero.
DfpDec(DfpField, byte) - Constructor for class org.apache.commons.math3.dfp.DfpDec
Create an instance from a byte value.
DfpDec(DfpField, int) - Constructor for class org.apache.commons.math3.dfp.DfpDec
Create an instance from an int value.
DfpDec(DfpField, long) - Constructor for class org.apache.commons.math3.dfp.DfpDec
Create an instance from a long value.
DfpDec(DfpField, double) - Constructor for class org.apache.commons.math3.dfp.DfpDec
Create an instance from a double value.
DfpDec(Dfp) - Constructor for class org.apache.commons.math3.dfp.DfpDec
Copy constructor.
DfpDec(DfpField, String) - Constructor for class org.apache.commons.math3.dfp.DfpDec
Create an instance from a String representation.
DfpDec(DfpField, byte, byte) - Constructor for class org.apache.commons.math3.dfp.DfpDec
Creates an instance with a non-finite value.
DfpField - Class in org.apache.commons.math3.dfp
Field for Decimal floating point instances.
DfpField(int) - Constructor for class org.apache.commons.math3.dfp.DfpField
Create a factory for the specified number of radix digits.
DfpField.RoundingMode - Enum in org.apache.commons.math3.dfp
Enumerate for rounding modes.
DfpMath - Class in org.apache.commons.math3.dfp
Mathematical routines for use with Dfp.
DftNormalization - Enum in org.apache.commons.math3.transform
This enumeration defines the various types of normalizations that can be applied to discrete Fourier transforms (DFT).
DiagonalMatrix - Class in org.apache.commons.math3.linear
Implementation of a diagonal matrix.
DiagonalMatrix(int) - Constructor for class org.apache.commons.math3.linear.DiagonalMatrix
Creates a matrix with the supplied dimension.
DiagonalMatrix(double[]) - Constructor for class org.apache.commons.math3.linear.DiagonalMatrix
Creates a matrix using the input array as the underlying data.
DiagonalMatrix(double[], boolean) - Constructor for class org.apache.commons.math3.linear.DiagonalMatrix
Creates a matrix using the input array as the underlying data.
difference(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Compute the difference of two regions.
DifferentiableIntegrableUnivariateFunction - Interface in org.apache.commons.math3.analysis
Extension of UnivariateFunction representing a differentiable and integrable univariate real function.
DifferentiableMultivariateFunction - Interface in org.apache.commons.math3.analysis
Deprecated. as of 3.1 replaced by MultivariateDifferentiableFunction
DifferentiableMultivariateMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
DifferentiableMultivariateMultiStartOptimizer(DifferentiableMultivariateOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.DifferentiableMultivariateMultiStartOptimizer
Deprecated. Create a multi-start optimizer from a single-start optimizer.
DifferentiableMultivariateOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
DifferentiableMultivariateVectorFunction - Interface in org.apache.commons.math3.analysis
Deprecated. as of 3.1 replaced by MultivariateDifferentiableVectorFunction
DifferentiableMultivariateVectorMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
DifferentiableMultivariateVectorMultiStartOptimizer(DifferentiableMultivariateVectorOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.DifferentiableMultivariateVectorMultiStartOptimizer
Deprecated. Create a multi-start optimizer from a single-start optimizer.
DifferentiableMultivariateVectorOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
DifferentiableUnivariateFunction - Interface in org.apache.commons.math3.analysis
Deprecated. as of 3.1 replaced by UnivariateDifferentiableFunction
DifferentiableUnivariateMatrixFunction - Interface in org.apache.commons.math3.analysis
Deprecated. as of 3.1 replaced by UnivariateDifferentiableMatrixFunction
DifferentiableUnivariateSolver - Interface in org.apache.commons.math3.analysis.solvers
Deprecated. as of 3.1, replaced by UnivariateDifferentiableSolver
DifferentiableUnivariateVectorFunction - Interface in org.apache.commons.math3.analysis
Deprecated. as of 3.1 replaced by UnivariateDifferentiableVectorFunction
DifferentialOrbitConverter - Class in org.orekit.propagation.analytical.tle
Orbit converter for Two-Lines Elements using differential algorithm.
DifferentialOrbitConverter(int, int, char, int, int, String, int, int) - Constructor for class org.orekit.propagation.analytical.tle.DifferentialOrbitConverter
Simple constructor.
differentiate(UnivariateFunction) - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Create an implementation of a differential from a regular function.
differentiate(UnivariateVectorFunction) - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Create an implementation of a differential from a regular vector function.
differentiate(UnivariateMatrixFunction) - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Create an implementation of a differential from a regular matrix function.
differentiate(double, UnivariateFunction) - Method in class org.apache.commons.math3.analysis.differentiation.RiddersDifferentiator
Differentiates a UnivariateFunction on a single point using the Ridders method.
differentiate(UnivariateFunction) - Method in class org.apache.commons.math3.analysis.differentiation.RiddersDifferentiator
Create an implementation of a differential from a regular function.
differentiate(UnivariateFunction) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateFunctionDifferentiator
Create an implementation of a differential from a regular function.
differentiate(UnivariateMatrixFunction) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateMatrixFunctionDifferentiator
Create an implementation of a differential from a regular matrix function.
differentiate(UnivariateVectorFunction) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateVectorFunctionDifferentiator
Create an implementation of a differential from a regular vector function.
differentiate(double[]) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns the coefficients of the derivative of the polynomial with the given coefficients.
differentiateQuaternion(Quaternion, Vector3D) - Static method in class org.orekit.attitudes.kinematics.KinematicsToolkit
Compute the derivative of a quaternion knowing the instantaneous spin.
DIFFUSION_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
Parameter name for diffusion coefficient.
DIFFUSION_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
Parameter name for diffusion coefficient.
digamma(double) - Static method in class org.apache.commons.math3.special.Gamma
Computes the digamma function of x.
DIGEST_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Use empirical distribution.
DihedralFieldOfViewDetector - Class in org.orekit.propagation.events
Finder for body entering/exiting dihedral fov events.
DihedralFieldOfViewDetector(PVCoordinatesProvider, Vector3D, Vector3D, double, Vector3D, double, double) - Constructor for class org.orekit.propagation.events.DihedralFieldOfViewDetector
Build a new instance.
DihedralFieldOfViewDetector(PVCoordinatesProvider, Vector3D, Vector3D, double, Vector3D, double, double, double) - Constructor for class org.orekit.propagation.events.DihedralFieldOfViewDetector
Build a new instance.
DihedralFieldOfViewDetector(PVCoordinatesProvider, Vector3D, Vector3D, double, Vector3D, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.DihedralFieldOfViewDetector
Build a new instance.
DihedralFieldOfViewDetector(PVCoordinatesProvider, Vector3D, Vector3D, double, Vector3D, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.DihedralFieldOfViewDetector
Build a new instance.
DihedralFieldOfViewDetector(PVCoordinatesProvider, Vector3D, Vector3D, double, Vector3D, double, double, EventDetector.Action, EventDetector.Action, double) - Constructor for class org.orekit.propagation.events.DihedralFieldOfViewDetector
Build a new instance.
DihedralFieldOfViewDetector(PVCoordinatesProvider, Vector3D, Vector3D, double, Vector3D, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean, double) - Constructor for class org.orekit.propagation.events.DihedralFieldOfViewDetector
Build a new instance.
DimensionMismatchException - Exception in org.apache.commons.math3.exception
Exception to be thrown when two dimensions differ.
DimensionMismatchException(Localizable, int, int) - Constructor for exception org.apache.commons.math3.exception.DimensionMismatchException
Construct an exception from the mismatched dimensions.
DimensionMismatchException(int, int) - Constructor for exception org.apache.commons.math3.exception.DimensionMismatchException
Construct an exception from the mismatched dimensions.
DirectionTrackingOrientation - Class in org.orekit.attitudes
 
DirectionTrackingOrientation(IDirection, Vector3D, Vector3D) - Constructor for class org.orekit.attitudes.DirectionTrackingOrientation
Constructor.
DirectoryCrawler - Class in org.orekit.data
Provider for data files stored in a directories tree on filesystem.
DirectoryCrawler(File) - Constructor for class org.orekit.data.DirectoryCrawler
Build a data files crawler.
DirectRadiativeModel - Class in fr.cnes.sirius.patrius.assembly.models
Class that represents a radiative model, based on the vehicle.
DirectRadiativeModel(Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
Radiative model (the acceleration is computed from all the sub parts of the vehicle).
DirectRadiativeModel(Assembly, double) - Constructor for class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
Radiative model (the acceleration is computed from all the sub parts of the vehicle).
DirectRadiativeModel(Assembly, Parameter) - Constructor for class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
Radiative model (the acceleration is computed from all the sub parts of the vehicle).
DirectRadiativeWrenchModel - Class in fr.cnes.sirius.patrius.assembly.models
This class represents a spacecraft capable of computing the wrench caused by solar radiation pressure.
DirectRadiativeWrenchModel(Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeWrenchModel
Radiative model (the acceleration is computed from all the sub parts of the vehicle).
discardFrontElements(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Discards the i initial elements of the array.
discardMostRecentElements(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Discards the i last elements of the array.
discretize(Vector2D, Vector2D, double, boolean) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Generate additional vertices between two points.
discretizeAndApplyTo(List<GeodeticPoint>, EnumLineProperty, double) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Discretizes a polygon conforming to a line property directive, and a maximum length of discretization.
discretizeCircleAndApplyTo(List<GeodeticPoint>, double) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Discretize following great circle lines between vertices of polygon and project obtained points.
discretizeGreatCircle(GeodeticPoint, GeodeticPoint, double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Discretize a great circle into N segments, between two points.
discretizeRhumbAndApplyTo(List<GeodeticPoint>, double) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Project a rhumb line polygon, with the given projection.
discretizeRhumbLine(GeodeticPoint, GeodeticPoint, double) - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Discretize a rhumb line into N segments, between two points.
Disk - Class in org.apache.commons.math3.geometry.euclidean.threed
Implements a representation of a disk.
Disk(Vector3D, Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Disk
Constructs the disk.
displace(Screw, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Screw
Displace this screw, using Chasles
displace(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Screw
Displace this screw, using Chasles
displace(Vector3D) - Method in class org.orekit.wrenches.Wrench
Displace current wrench.
displace(Wrench, Vector3D) - Static method in class org.orekit.wrenches.Wrench
Displace current wrench.
distance(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between the instance and another vector according to the L2 norm.
distance(Vector1D, Vector1D) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between two vectors according to the L2 norm.
distance(FieldRotation<T>, FieldRotation<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Compute the distance between two rotations.
distance(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L2 norm.
distance(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L2 norm.
distance(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L2 norm.
distance(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L2 norm.
distance(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L2 norm.
distance(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Compute the distance between the instance and a point.
distance(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Compute the shortest distance between the instance and another line.
distance(Rotation, Rotation) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Compute the distance between two rotations.
distance(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between the instance and another vector according to the L2 norm.
distance(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between two vectors according to the L2 norm.
distance(Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Compute the distance between the instance and a point.
distance(Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
Calculates the shortest distance from a point to this line segment.
distance(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between the instance and another vector according to the L2 norm.
distance(Vector2D, Vector2D) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between two vectors according to the L2 norm.
distance(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the distance between the instance and another vector according to the L2 norm.
distance(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L2 (Euclidean) distance between two points.
distance(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L2 (Euclidean) distance between two points.
distance1(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L1 norm.
distance1(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L1 norm.
distance1(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L1 norm.
distance1(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between two vectors according to the L1 norm.
distance1(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between the instance and another vector according to the L1 norm.
distance1(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the distance between the instance and another vector according to the L1 norm.
distance1(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L1 (sum of abs) distance between two points.
distance1(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L1 (sum of abs) distance between two points.
DistanceDetector - Class in org.orekit.propagation.events
Detects when the distance from the spacecraft to a given body reaches a predetermined value.
DistanceDetector(PVCoordinatesProvider, double) - Constructor for class org.orekit.propagation.events.DistanceDetector
Constructor for a DistanceDetector instance.
DistanceDetector(PVCoordinatesProvider, double, double, double) - Constructor for class org.orekit.propagation.events.DistanceDetector
Constructor for a DistanceDetector instance with complimentary parameters.
DistanceDetector(PVCoordinatesProvider, double, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.DistanceDetector
Constructor for a DistanceDetector instance with complimentary parameters.
DistanceDetector(PVCoordinatesProvider, double, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.DistanceDetector
Constructor for a DistanceDetector instance with complimentary parameters.
distanceFrom(T) - Method in interface org.apache.commons.math3.stat.clustering.Clusterable
Returns the distance from the given point.
distanceFrom(EuclideanDoublePoint) - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Returns the distance from the given point.
distanceFrom(EuclideanIntegerPoint) - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Returns the distance from the given point.
distanceInf(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(Vector1D, Vector1D) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the distance between two vectors according to the L norm.
distanceInf(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L norm.
distanceInf(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L norm.
distanceInf(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the distance between two vectors according to the L norm.
distanceInf(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the distance between two vectors according to the L norm.
distanceInf(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between the instance and another vector according to the L norm.
distanceInf(Vector2D, Vector2D) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the distance between two vectors according to the L norm.
distanceInf(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the distance between the instance and another vector according to the L norm.
distanceInf(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L (max of abs) distance between two points.
distanceInf(int[], int[]) - Static method in class org.apache.commons.math3.util.MathArrays
Calculates the L (max of abs) distance between two points.
distanceSq(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the square of the distance between the instance and another vector.
distanceSq(Vector1D, Vector1D) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the square of the distance between two vectors.
distanceSq(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between the instance and another vector.
distanceSq(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between the instance and another vector.
distanceSq(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between two vectors.
distanceSq(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between two vectors.
distanceSq(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the square of the distance between two vectors.
distanceSq(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the square of the distance between the instance and another vector.
distanceSq(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the square of the distance between two vectors.
distanceSq(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the square of the distance between the instance and another vector.
distanceSq(Vector2D, Vector2D) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the square of the distance between two vectors.
distanceSq(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the square of the distance between the instance and another vector.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
Computes the distance to a line.
distanceTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
Computes the shortest distance from a point to the ellipse.
distanceTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Computes the distance to the closest point on the ellipsoid.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Get the smallest distance from the line to the ellipsoid
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
Computes the distance to a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
Computes the distance to a line.
distanceTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
 
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Get the smallest distance from the line to the cone
distanceTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
 
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
Get the smallest distance from the line to the cone
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
Computes the distance to a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
Computes the distance to a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCone
Computes the distance to a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
Computes the distance to a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.LineSegment
Computes the shortest distance to a line of space.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
Computes the distance to a line.
distanceTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Computes the distance between this plane and a point of space.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Computes the distance between this plane and a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
Computes the distance to a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
Computes the distance to a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
Computes the distance to a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
Computes the distance to a line.
distanceTo(Line) - Method in interface org.apache.commons.math3.geometry.euclidean.threed.Shape
Computes the distance to a line.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Computes the distance to a line.
distanceTo(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Computes the distance to a point of space.
distanceTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCap
Gives the distance from the line to the spherical cap.
When the line intersects the spherical cap, the distance is 0.
distanceTo(Line, Frame, AbsoluteDate) - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
 
distanceTo(Line, Frame, AbsoluteDate) - Method in interface org.orekit.bodies.GeometricBodyShape
Computes the distance to a line.
DiurnalRotation - Class in org.orekit.frames.configuration
This class contains the different ut1-utc corrections (libration, tidal effects).
DiurnalRotation(TidalCorrectionModel, LibrationCorrectionModel) - Constructor for class org.orekit.frames.configuration.DiurnalRotation
Simple constructor.
divide(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'÷s;' operator.
divide(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'÷s;' operator.
divide(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform division of two derivative structures.
Divide - Class in org.apache.commons.math3.analysis.function
Divide the first operand by the second.
Divide() - Constructor for class org.apache.commons.math3.analysis.function.Divide
 
divide(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this / divisor).
divide(double) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this / divisor), with divisor interpreted as a real number.
divide(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Divide this by divisor.
divide(int) - Method in class org.apache.commons.math3.dfp.Dfp
Divide by a single digit less than radix.
divide(T) - Method in interface org.apache.commons.math3.FieldElement
Compute this ÷ a.
divide(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
Divide the value of this fraction by the passed BigInteger, ie this * 1 / bg, returning the result in reduced form.
divide(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Divide the value of this fraction by the passed int, ie this * 1 / i, returning the result in reduced form.
divide(long) - Method in class org.apache.commons.math3.fraction.BigFraction
Divide the value of this fraction by the passed long, ie this * 1 / l, returning the result in reduced form.
divide(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
Divide the value of this fraction by another, returning the result in reduced form.
divide(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
Divide the value of this fraction by another.
divide(int) - Method in class org.apache.commons.math3.fraction.Fraction
Divide the fraction by an integer.
divide(double) - Method in interface org.apache.commons.math3.RealFieldElement
'÷' operator.
divide(BigReal) - Method in class org.apache.commons.math3.util.BigReal
Compute this ÷ a.
divide(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute this ÷ a.
DividedDifferenceInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Implements the Divided Difference Algorithm for interpolation of real univariate functions.
DividedDifferenceInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator
 
dnet(double, double, double, double, double) - Method in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
dnet Turbopause correction for MSIS models root mean density.
doCopy() - Method in class org.apache.commons.math3.ode.nonstiff.RungeKutta6StepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Really copy the finalized instance.
doCopy() - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Really copy the finalized instance.
doFinalize() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Really finalize the step.
doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Method for implementing actual integration algorithms in derived classes.
doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.IterativeLegendreGaussIntegrator
Method for implementing actual integration algorithms in derived classes.
doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.LegendreGaussIntegrator
Deprecated. Method for implementing actual integration algorithms in derived classes.
doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.RombergIntegrator
Method for implementing actual integration algorithms in derived classes.
doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
Method for implementing actual integration algorithms in derived classes.
doIntegrate() - Method in class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
Method for implementing actual integration algorithms in derived classes.
doIteration(SimplexTableau) - Method in class org.apache.commons.math3.optim.linear.SimplexSolver
Runs one iteration of the Simplex method on the given model.
doIteration(SimplexTableau) - Method in class org.apache.commons.math3.optimization.linear.SimplexSolver
Deprecated. Runs one iteration of the Simplex method on the given model.
doOptimize() - Method in class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.linear.SimplexSolver
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.PowellOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.SimplexOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.GaussNewtonOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.univariate.BrentOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optim.univariate.MultiStartUnivariateOptimizer
Performs the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated. Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.direct.PowellOptimizer
Deprecated. Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.direct.SimplexOptimizer
Deprecated. Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
Deprecated. Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated. Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated. Perform the bulk of the optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated. Perform the bulk of optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.linear.SimplexSolver
Deprecated. Perform the bulk of optimization algorithm.
doOptimize() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated. Method for implementing actual optimization algorithms in derived classes.
doOptimize() - Method in class org.apache.commons.math3.optimization.univariate.BrentOptimizer
Deprecated. Method for implementing actual optimization algorithms in derived classes.
DormandPrince54Integrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince54Integrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
Simple constructor.
DormandPrince54Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
Simple constructor.
DormandPrince853Integrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince853Integrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
Simple constructor.
DormandPrince853Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
Simple constructor.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BisectionSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.BrentSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.MullerSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.MullerSolver2
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.NewtonRaphsonSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.NewtonSolver
Deprecated. Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.RiddersSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.apache.commons.math3.analysis.solvers.SecantSolver
Method for implementing actual optimization algorithms in derived classes.
doSolve() - Method in class org.orekit.propagation.OsculatingToMeanElementsConverter.NewtonSolverImp
Method for implementing actual optimization algorithms in derived classes.
dotProduct(Quaternion, Quaternion) - Static method in class org.apache.commons.math3.complex.Quaternion
Computes the dot-product of two quaternions.
dotProduct(Quaternion) - Method in class org.apache.commons.math3.complex.Quaternion
Computes the dot-product of the instance by a quaternion.
dotProduct(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Compute the dot-product of the instance and another vector.
dotProduct(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of the instance and another vector.
dotProduct(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of the instance and another vector.
dotProduct(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of two vectors.
dotProduct(FieldVector3D<T>, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of two vectors.
dotProduct(Vector3D, FieldVector3D<T>) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Compute the dot-product of two vectors.
dotProduct(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the dot-product of the instance and another vector.
dotProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Compute the dot-product of two vectors.
dotProduct(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Compute the dot-product of the instance and another vector.
dotProduct(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Compute the dot-product of the instance and another vector.
dotProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the dot product.
dotProduct(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the dot product.
dotProduct(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Compute the dot product of this vector with v.
dotProduct(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Compute the dot product.
dotProduct(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. as of 3.1 (to be removed in 4.0). The computation is performed by the parent class. The method must be kept to maintain backwards compatibility.
dotProduct(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Compute the dot product of this vector with v.
dotProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Compute the dot product.
dotrap(int, String, Dfp, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Raises a trap.
DOUBLE_COMPARISON_EPSILON - Static variable in class fr.cnes.sirius.patrius.utils.Comparators
The epsilon used for doubles relative comparison
DOUBLE_COMPARISON_EPSILON - Static variable in class fr.cnes.sirius.patrius.UtilsPatrius
Epsilon used for doubles relative comparison
DOUBLE_COMPARISON_EPSILON - Static variable in class org.apache.commons.math3.util.Precision
Epsilon used for doubles relative comparison
DOUBLE_COMPARISON_EPSILON - Static variable in class org.apache.commons.math3.UtilsCommonsMath
Epsilon used for doubles relative comparison
DoubleArray - Interface in org.apache.commons.math3.util
Provides a standard interface for double arrays.
DoubleDPFacade - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class is a facade for the use of double precision real numbers.
DoubleDPFacade(double) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.DoubleDPFacade
Simple constructor that store the given double value.
doubleValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a double.
doubleValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction as a double.
doubleValue() - Method in class org.apache.commons.math3.util.BigReal
Get the double value corresponding to the instance.
doubleValue() - Method in class org.apache.commons.math3.util.Decimal64
DOWN - Static variable in class org.orekit.propagation.events.LatitudeDetector
Flag for local decreasing latitude detection (g decreasing).
DOWNSIDE_VARIANCE - Static variable in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
The DOWNSIDE Direction is used to specify that the observations below the cutoff point will be used to calculate SemiVariance
dPert - Variable in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaGaussContribution
Value of the perturbation derivative
dPot - Variable in class fr.cnes.sirius.patrius.stela.forces.AbstractStelaLagrangeContribution
Value of the potential derivative
dragAcceleration(SpacecraftState, double, Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.AeroModel
Method to compute the aero acceleration, based on the assembly.
dragAcceleration(SpacecraftState, double, Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.DragLiftModel
Method to compute the aero acceleration, based on the assembly.
dragAcceleration(SpacecraftState, double, Vector3D) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaAeroModel
Return the drag acceleration in the CIRF frame.
dragAcceleration(SpacecraftState, double, Vector3D) - Method in interface org.orekit.forces.drag.DragSensitive
Compute the acceleration due to drag and the lift.
DragForce - Class in org.orekit.forces.drag
Atmospheric drag force model.
DragForce(Atmosphere, DragSensitive) - Constructor for class org.orekit.forces.drag.DragForce
Constructor with multiplicative factor k = 1.0.
DragForce(Atmosphere, DragSensitive, boolean, boolean) - Constructor for class org.orekit.forces.drag.DragForce
Constructor with multiplicative factor k = 1.0.
DragForce(double, Atmosphere, DragSensitive) - Constructor for class org.orekit.forces.drag.DragForce
Constructor with multiplicative factor k.
DragForce(double, Atmosphere, DragSensitive, boolean, boolean) - Constructor for class org.orekit.forces.drag.DragForce
Constructor with multiplicative factor k.
DragForce(Parameter, Atmosphere, DragSensitive) - Constructor for class org.orekit.forces.drag.DragForce
Constructor with multiplicative factor k.
DragForce(Parameter, Atmosphere, DragSensitive, boolean, boolean) - Constructor for class org.orekit.forces.drag.DragForce
Constructor with multiplicative factor k.
DragForce(IParamDiffFunction, Atmosphere, DragSensitive) - Constructor for class org.orekit.forces.drag.DragForce
Constructor with multiplicative factor k.
DragForce(IParamDiffFunction, Atmosphere, DragSensitive, boolean, boolean) - Constructor for class org.orekit.forces.drag.DragForce
Constructor with multiplicative factor k.
DragLiftModel - Class in fr.cnes.sirius.patrius.assembly.models
Class that represents an drag and lift aero model, based on the vehicle.
DragLiftModel(Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.models.DragLiftModel
Aero drag and lift model (the acceleration is computed from all the sub parts of the vehicle).
DragSensitive - Interface in org.orekit.forces.drag
Interface for spacecraft that are sensitive to atmospheric drag and lift forces.
dragWrench(SpacecraftState, double, Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.AeroWrenchModel
 
dragWrench(SpacecraftState, double, Vector3D, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.assembly.models.AeroWrenchModel
Compute the torque due to radiation pressire.
DragWrench - Class in fr.cnes.sirius.patrius.wrenches
This class represents a drag wrench model.
DragWrench(Atmosphere, DragWrenchSensitive) - Constructor for class fr.cnes.sirius.patrius.wrenches.DragWrench
Simple constructor.
dragWrench(SpacecraftState, double, Vector3D) - Method in interface fr.cnes.sirius.patrius.wrenches.DragWrenchSensitive
Compute the torque due to radiation pressire.
dragWrench(SpacecraftState, double, Vector3D, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.wrenches.DragWrenchSensitive
Compute the torque due to radiation pressire.
DragWrenchSensitive - Interface in fr.cnes.sirius.patrius.wrenches
Interface to represent solar drag wrench sensitive vehicles
DrozinerAttractionModel - Class in org.orekit.forces.gravity
This class represents the gravitational field of a celestial body.
DrozinerAttractionModel(Frame, double, double, double[][], double[][]) - Constructor for class org.orekit.forces.gravity.DrozinerAttractionModel
Creates a new instance.
DrozinerAttractionModel(Frame, double, double, double[][], double[][], boolean, boolean) - Constructor for class org.orekit.forces.gravity.DrozinerAttractionModel
Creates a new instance.
DrozinerAttractionModel(Frame, Parameter, Parameter, double[][], double[][]) - Constructor for class org.orekit.forces.gravity.DrozinerAttractionModel
Creates a new instance using Parameter.
DrozinerAttractionModel(Frame, Parameter, Parameter, double[][], double[][], boolean, boolean) - Constructor for class org.orekit.forces.gravity.DrozinerAttractionModel
Creates a new instance using Parameter.
DSCompiler - Class in org.apache.commons.math3.analysis.differentiation
Class holding "compiled" computation rules for derivative structures.
DstNormalization - Enum in org.apache.commons.math3.transform
This enumeration defines the various types of normalizations that can be applied to discrete sine transforms (DST).
DTM2000 - Class in org.orekit.forces.atmospheres
This atmosphere model is the realization of the DTM-2000 model.
DTM2000(DTM2000InputParameters, PVCoordinatesProvider, BodyShape) - Constructor for class org.orekit.forces.atmospheres.DTM2000
Simple constructor for independent computation.
DTM2000InputParameters - Interface in org.orekit.forces.atmospheres
Container for solar activity data, compatible with DTM2000 Atmosphere model.
DTM2000SolarData - Class in org.orekit.forces.atmospheres.solarActivity.specialized
This class represents a solar data container adapted for the DTM2000 atmosphere model
DTM2000SolarData(SolarActivityDataProvider) - Constructor for class org.orekit.forces.atmospheres.solarActivity.specialized.DTM2000SolarData
Constructor.
DummyLocalizable - Class in org.apache.commons.math3.exception.util
Dummy implementation of the Localizable interface, without localization.
DummyLocalizable(String) - Constructor for class org.apache.commons.math3.exception.util.DummyLocalizable
Simple constructor.
DummyStepHandler - Class in org.apache.commons.math3.ode.sampling
This class is a step handler that does nothing.
durationFrom(AbsoluteDate) - Method in class org.orekit.time.AbsoluteDate
Compute the physically elapsed duration between two instants.
durationFrom(AbsoluteDateInterval) - Method in class org.orekit.utils.AbsoluteDateInterval
Computes the duration in seconds between the two intervals.
The duration between two intervals is the duration between the end of the earlier interval and the beginning of the later.
If the intervals overlap, this duration is 0.
The sign of the result is positive if the given interval comes earlier.
durationFromTab - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
The array of time duration from the first entry of data, chronologically sorted.
DurationTools - Class in fr.cnes.sirius.validate.duration
Tests class for duration test
DurationTools(String, String) - Constructor for class fr.cnes.sirius.validate.duration.DurationTools
DurationTools constructor

E

E - Static variable in class org.apache.commons.math3.util.FastMath
Napier's constant e, base of the natural logarithm.
e - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
final eccentricity.
e0sq - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
original eccentricity squared.
E2 - Static variable in class org.orekit.forces.radiation.KnockeRiesModel
coefficient a2 of Knocke-Ries model.
EARTH - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Earth.
EARTH_MOON - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Earth-Moon barycenter.
EarthCenterDirection - Class in org.orekit.attitudes.directions
Direction to Earth body center : the central body's center is the target point.
EarthCenterDirection() - Constructor for class org.orekit.attitudes.directions.EarthCenterDirection
Constructor for Earth center direction.
EarthGravitationalModelFactory - Class in org.orekit.forces.gravity
Factory class for earth gravitational model.
EarthGravitationalModelFactory.GravityFieldNames - Enum in org.orekit.forces.gravity
Gravity field names enumerate.
EarthRotation - Class in fr.cnes.sirius.patrius.stela.bodies
This class represents the Earth rotation.
EarthZoneDetector - Class in fr.cnes.sirius.patrius.events
Detects when the satellite enters a ground zone (several zones can be defined at the same time).
EarthZoneDetector(BodyShape, List<double[][]>) - Constructor for class fr.cnes.sirius.patrius.events.EarthZoneDetector
Constructor for the earth zones entering detector with default maxCheck and convergence threshold.
EarthZoneDetector(BodyShape, List<double[][]>, double, double) - Constructor for class fr.cnes.sirius.patrius.events.EarthZoneDetector
Constructor for the earth zones entering detector.
EarthZoneDetector(BodyShape, List<double[][]>, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.EarthZoneDetector
Constructor for the earth zones entering detector.
EarthZoneDetector(BodyShape, List<double[][]>, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.EarthZoneDetector
Constructor for the earth zones entering detector.
EarthZoneDetector(List<Vector3D[]>, Frame) - Constructor for class fr.cnes.sirius.patrius.events.EarthZoneDetector
Constructor for the earth zones entering detector with default maxCheck and convergence threshold.
EarthZoneDetector(List<Vector3D[]>, Frame, double, double) - Constructor for class fr.cnes.sirius.patrius.events.EarthZoneDetector
Constructor for the earth zones entering detector.
EarthZoneDetector(List<Vector3D[]>, Frame, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.EarthZoneDetector
Constructor for the earth zones entering detector.
EarthZoneDetector(List<Vector3D[]>, Frame, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.EarthZoneDetector
Constructor.
ebeAdd(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates an array whose contents will be the element-by-element addition of the arguments.
ebeDivide(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Element-by-element division.
ebeDivide(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Element-by-element division.
ebeDivide(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Element-by-element division.
ebeDivide(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Element-by-element division.
ebeDivide(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Element-by-element division.
ebeDivide(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Deprecated. As of version 3.1, this method is deprecated, and will be removed in version 4.0. This decision follows the discussion reported in MATH-803. Uses of this method involving sparse implementations of RealVector might lead to wrong results. Since there is no satisfactory correction to this bug, this method is deprecated. Users who want to preserve this feature are advised to implement RealVectorPreservingVisitor (possibly ignoring corner cases for the sake of efficiency).
ebeDivide(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Element-by-element division.
ebeDivide(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates an array whose contents will be the element-by-element division of the first argument by the second.
ebeMultiply(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Element-by-element multiplication.
ebeMultiply(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Element-by-element multiplication.
ebeMultiply(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Element-by-element multiplication.
ebeMultiply(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Element-by-element multiplication.
ebeMultiply(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Element-by-element multiplication.
ebeMultiply(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Deprecated. As of version 3.1, this method is deprecated, and will be removed in version 4.0. This decision follows the discussion reported in MATH-803. Uses of this method involving sparse implementations of RealVector might lead to wrong results. Since there is no satisfactory correction to this bug, this method is deprecated. Users who want to preserve this feature are advised to implement RealVectorPreservingVisitor (possibly ignoring corner cases for the sake of efficiency).
ebeMultiply(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Element-by-element multiplication.
ebeMultiply(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates an array whose contents will be the element-by-element multiplication of the arguments.
ebeSubtract(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Creates an array whose contents will be the element-by-element subtraction of the second argument from the first.
ECCENTRIC_ANOMALY - Static variable in class org.orekit.orbits.KeplerianOrbit
Deprecated. as of 6.0 replaced by PositionAngle
ECCENTRIC_LATITUDE_ARGUMENT - Static variable in class org.orekit.orbits.EquinoctialOrbit
Deprecated. as of 6.0 replaced by PositionAngle
ECCENTRIC_LONGITUDE_ARGUMENT - Static variable in class org.orekit.orbits.CircularOrbit
Deprecated. as of 6.0 replaced by PositionAngle
EcksteinHechlerPropagator - Class in org.orekit.propagation.analytical
This class propagates a SpacecraftState using the analytical Eckstein-Hechler model.
EcksteinHechlerPropagator(Orbit, double, double, Frame, double, double, double, double, double, ParametersType) - Constructor for class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Build a propagator from orbit and potential.
EcksteinHechlerPropagator(Orbit, double, double, Frame, double, double, double, double, double, MassProvider, ParametersType) - Constructor for class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Build a propagator from orbit, mass and potential.
EcksteinHechlerPropagator(Orbit, AttitudeProvider, double, double, Frame, double, double, double, double, double, ParametersType) - Constructor for class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Build a propagator from orbit, attitude provider and potential.
EcksteinHechlerPropagator(Orbit, AttitudeProvider, AttitudeProvider, double, double, Frame, double, double, double, double, double, ParametersType) - Constructor for class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Build a propagator from orbit, attitude provider for forces and events computation and potential.
EcksteinHechlerPropagator(Orbit, AttitudeProvider, double, double, Frame, double, double, double, double, double, MassProvider, ParametersType) - Constructor for class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Build a propagator from orbit, attitude provider, mass and potential.
EcksteinHechlerPropagator(Orbit, AttitudeProvider, AttitudeProvider, double, double, Frame, double, double, double, double, double, MassProvider, ParametersType) - Constructor for class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Build a propagator from orbit, attitude provider, mass and potential.
EclipseDetector - Class in org.orekit.propagation.events
Finder for satellite eclipse related events.
EclipseDetector(PVCoordinatesProvider, double, GeometricBodyShape, boolean) - Constructor for class org.orekit.propagation.events.EclipseDetector
Deprecated. 
EclipseDetector(PVCoordinatesProvider, double, GeometricBodyShape, boolean, double, double) - Constructor for class org.orekit.propagation.events.EclipseDetector
Deprecated. 
EclipseDetector(PVCoordinatesProvider, double, PVCoordinatesProvider, double, boolean) - Constructor for class org.orekit.propagation.events.EclipseDetector
Deprecated. 
EclipseDetector(PVCoordinatesProvider, double, PVCoordinatesProvider, double, boolean, double) - Constructor for class org.orekit.propagation.events.EclipseDetector
Deprecated. 
EclipseDetector(PVCoordinatesProvider, double, PVCoordinatesProvider, double, boolean, double, double) - Constructor for class org.orekit.propagation.events.EclipseDetector
Deprecated. 
EclipseDetector(PVCoordinatesProvider, double, PVCoordinatesProvider, double) - Constructor for class org.orekit.propagation.events.EclipseDetector
Deprecated. 
EclipseDetector(PVCoordinatesProvider, double, PVCoordinatesProvider, double, double) - Constructor for class org.orekit.propagation.events.EclipseDetector
Deprecated. 
EclipseDetector(PVCoordinatesProvider, double, PVCoordinatesProvider, double, double, double) - Constructor for class org.orekit.propagation.events.EclipseDetector
Deprecated. 
EclipseDetector(IDirection, PVCoordinatesProvider, double, double, double) - Constructor for class org.orekit.propagation.events.EclipseDetector
Build a new eclipse detector.
EclipseDetector(IDirection, PVCoordinatesProvider, double, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.EclipseDetector
Build a new eclipse detector with defined actions when entering and exiting the eclipse.
EclipseDetector(IDirection, PVCoordinatesProvider, double, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.EclipseDetector
Build a new eclipse detector with defined actions when entering and exiting the eclipse.
EclipseDetector(PVCoordinatesProvider, double, PVCoordinatesProvider, double, double, double, double) - Constructor for class org.orekit.propagation.events.EclipseDetector
Build a new eclipse detector based on a lighting ratio.
EclipseDetector(PVCoordinatesProvider, double, PVCoordinatesProvider, double, double, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.EclipseDetector
Build a new eclipse detector based on a lighting ratio.
EclipseDetector(PVCoordinatesProvider, double, PVCoordinatesProvider, double, double, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.EclipseDetector
Build a new eclipse detector based on a lighting ratio.
EclipseDetector(PVCoordinatesProvider, double, GeometricBodyShape, double, double, double) - Constructor for class org.orekit.propagation.events.EclipseDetector
Build a new eclipse detector based on a lighting ratio.
EclipseDetector(PVCoordinatesProvider, double, GeometricBodyShape, double, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.EclipseDetector
Build a new eclipse detector based on a lighting ratio.
EclipseDetector(PVCoordinatesProvider, double, GeometricBodyShape, double, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.EclipseDetector
Build a new eclipse detector based on a lighting ratio.
eeta - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
original eccentricity * eta.
EGM96_EARTH_C20 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized second zonal coefficient from EGM96 model: -1.08262668355315e-3.
EGM96_EARTH_C30 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized third zonal coefficient from EGM96 model: 2.53265648533224e-6.
EGM96_EARTH_C40 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized fourth zonal coefficient from EGM96 model: 1.619621591367e-6.
EGM96_EARTH_C50 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized fifth zonal coefficient from EGM96 model: 2.27296082868698e-7.
EGM96_EARTH_C60 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized sixth zonal coefficient from EGM96 model: -5.40681239107085e-7.
EGM96_EARTH_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.Constants
Earth equatorial radius from EGM96 model: 6378136.3 m.
EGM96_EARTH_MU - Static variable in interface org.orekit.utils.Constants
Earth gravitational constant from EGM96 model: 3.986004415 m3/s2.
EGM_FILENAME - Static variable in class org.orekit.forces.gravity.potential.GravityFieldFactory
Default regular expression for EGM files.
EGMFormatReader - Class in org.orekit.forces.gravity.potential
This reader is adapted to the EGM Format.
EGMFormatReader(String, boolean) - Constructor for class org.orekit.forces.gravity.potential.EGMFormatReader
Simple constructor.
EIGEN5C_EARTH_C20 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized second zonal coefficient from EIGEN5C model: -1.082626457231767e-3.
EIGEN5C_EARTH_C30 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized third zonal coefficient from EIGEN5C model: 2.532547231862799e-6.
EIGEN5C_EARTH_C40 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized fourth zonal coefficient from EIGEN5C model: 1.619964434136e-6.
EIGEN5C_EARTH_C50 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized fifth zonal coefficient from EIGEN5C model: 2.277928487005437e-7.
EIGEN5C_EARTH_C60 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized sixth zonal coefficient from EIGEN5C model: -5.406653715879098e-7.
EIGEN5C_EARTH_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.Constants
Earth equatorial radius from EIGEN5C model: 6378136.46 m.
EIGEN5C_EARTH_MU - Static variable in interface org.orekit.utils.Constants
Earth gravitational constant from EIGEN5C model: 3.986004415 m3/s2.
EigenDecomposition - Class in org.apache.commons.math3.linear
Calculates the eigen decomposition of a real matrix.
EigenDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.EigenDecomposition
Calculates the eigen decomposition of the given real matrix.
EigenDecomposition(RealMatrix, double) - Constructor for class org.apache.commons.math3.linear.EigenDecomposition
Deprecated. in 3.1 (to be removed in 4.0) due to unused parameter
EigenDecomposition(double[], double[]) - Constructor for class org.apache.commons.math3.linear.EigenDecomposition
Calculates the eigen decomposition of the symmetric tridiagonal matrix.
EigenDecomposition(double[], double[], double) - Constructor for class org.apache.commons.math3.linear.EigenDecomposition
Deprecated. in 3.1 (to be removed in 4.0) due to unused parameter
ElementaryFlux - Class in org.orekit.forces.radiation
Elementary flux
ElementaryFlux(Vector3D, double, double) - Constructor for class org.orekit.forces.radiation.ElementaryFlux
Constructor of elementary pressure
elementaryMultiplication(TrigonometricPolynomialFunction, ElementaryMultiplicationTypes.ElementaryType, int) - Static method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Multiply TrigonometricPolynomialFunction by an ElementaryMultiplicationTypes
ElementaryMultiplicationTypes - Class in org.apache.commons.math3.analysis.polynomials
This class is used to represent elementary trigonometric polynomials cos and sin.
ElementaryMultiplicationTypes.ElementaryType - Enum in org.apache.commons.math3.analysis.polynomials
Elementary trigonometric types
ElementTypeFilter - Class in fr.cnes.sirius.patrius.events.postprocessing
 
ElementTypeFilter(String, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.ElementTypeFilter
Constructor that uses only one code to identify the elements that have to be removed/kept.
ElementTypeFilter(List<String>, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.ElementTypeFilter
Constructor that uses a list of codes to identify the elements that have to be removed/kept.
ElevationDetector - Class in org.orekit.propagation.events
Finder for satellite raising/setting events.
ElevationDetector(double, TopocentricFrame) - Constructor for class org.orekit.propagation.events.ElevationDetector
Build a new elevation detector.
ElevationDetector(double, TopocentricFrame, double) - Constructor for class org.orekit.propagation.events.ElevationDetector
Build a new elevation detector.
ElevationDetector(double, TopocentricFrame, double, double) - Constructor for class org.orekit.propagation.events.ElevationDetector
Build a new elevation detector.
ElevationDetector(double, TopocentricFrame, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ElevationDetector
Build a new elevation detector.
ElevationDetector(double, TopocentricFrame, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.ElevationDetector
Build a new elevation detector.
ElitisticListPopulation - Class in org.apache.commons.math3.genetics
Population of chromosomes which uses elitism (certain percentage of the best chromosomes is directly copied to the next generation).
ElitisticListPopulation(List<Chromosome>, int, double) - Constructor for class org.apache.commons.math3.genetics.ElitisticListPopulation
Creates a new ElitisticListPopulation instance.
ElitisticListPopulation(int, double) - Constructor for class org.apache.commons.math3.genetics.ElitisticListPopulation
Creates a new ElitisticListPopulation instance and initializes its inner chromosome list.
Ellipse - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for an ellipse in 3D space, with some algorithm to compute intersections and distances to some other objects.
Ellipse(Vector3D, Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Ellipse
Build an ellipse in the 3D space from its center, normal vector, approximative U vector of the local frame, and two radiuses.
Ellipsoid - Class in org.apache.commons.math3.geometry.euclidean.threed
This is the Ellipsoid (also called Revolved Ellipsoid) class.This class cannot represent all ellipsoid objects.
Ellipsoid(Vector3D, Vector3D, Vector3D, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
This constructor builds a ellipsoid from its centers position, its revolution axis and its transverse and conjugate radii.
EllipticCone - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D oblique circular cone ended by a plane normal to its axis, with some algorithm to compute intersections and distances to some other objects.
EllipticCone(Vector3D, Vector3D, Vector3D, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
Build an oblique circular cone from its radius, the height, the origin (apex), the approximative u vector of the local frame and direction of its axis.
EllipticCylinder - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D oblique circular cylinder ended by two planes normal to its axis, with some algorithm to compute intersections and distances to some other objects.
EllipticCylinder(Vector3D, Vector3D, Vector3D, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
Build an oblique circular cylinder from its radiuses, the height, the origin, the approximative u vector of the local frame and the direction of its axis.
EllipticField - Class in fr.cnes.sirius.patrius.fieldsofview
This class describes an elliptic field of view to be used in "instruments" part properties.
EllipticField(String, Vector3D, Vector3D, Vector3D, double, double) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.EllipticField
Constructor for an elliptic field of view.
EmbeddedRungeKuttaIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.
EmbeddedRungeKuttaIntegrator(String, boolean, double[], double[][], double[], RungeKuttaStepInterpolator, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Build a Runge-Kutta integrator with the given Butcher array.
EmbeddedRungeKuttaIntegrator(String, boolean, double[], double[][], double[], RungeKuttaStepInterpolator, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Build a Runge-Kutta integrator with the given Butcher array.
Embedding<S extends Space,T extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface defines mappers between a space and one of its sub-spaces.
EME2000_ALIGNED - Static variable in class org.orekit.attitudes.InertialProvider
Deprecated. Dummy attitude provider, perfectly aligned with the EME2000 frame.
EME2000Provider - Class in org.orekit.frames.transformations
EME2000 frame : mean equator at J2000.0.
EME2000Provider() - Constructor for class org.orekit.frames.transformations.EME2000Provider
Simple constructor.
EmpiricalDistribution - Class in org.apache.commons.math3.random
Represents an empirical probability distribution -- a probability distribution derived from observed data without making any assumptions about the functional form of the population distribution that the data come from.
EmpiricalDistribution() - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Creates a new EmpiricalDistribution with the default bin count.
EmpiricalDistribution(int) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Creates a new EmpiricalDistribution with the specified bin count.
EmpiricalDistribution(int, RandomGenerator) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Creates a new EmpiricalDistribution with the specified bin count using the provided RandomGenerator as the source of random data.
EmpiricalDistribution(RandomGenerator) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Creates a new EmpiricalDistribution with default bin count using the provided RandomGenerator as the source of random data.
EmpiricalDistribution(int, RandomDataImpl) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Deprecated. As of 3.1. Please use EmpiricalDistribution.EmpiricalDistribution(int,RandomGenerator) instead.
EmpiricalDistribution(RandomDataImpl) - Constructor for class org.apache.commons.math3.random.EmpiricalDistribution
Deprecated. As of 3.1. Please use EmpiricalDistribution.EmpiricalDistribution(RandomGenerator) instead.
EmpiricalForce - Class in fr.cnes.sirius.patrius.forces
This class implements the empirical force.
EmpiricalForce(int, Vector3D, Vector3D, Vector3D, Vector3D, Frame) - Constructor for class fr.cnes.sirius.patrius.forces.EmpiricalForce
Simple constructor for an empiric force, assigning a generic frame to the A, B, C coefficients frame.
EmpiricalForce(int, Vector3D, Vector3D, Vector3D, Vector3D, LOFType) - Constructor for class fr.cnes.sirius.patrius.forces.EmpiricalForce
Simple constructor for an empiric force.
EmpiricalForce(int, Vector3D, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, LOFType) - Constructor for class fr.cnes.sirius.patrius.forces.EmpiricalForce
Simple constructor for an empiric force using Parameter for A; B and C coef with a given LOF frame.
EmpiricalForce(int, Vector3D, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, Parameter, Frame) - Constructor for class fr.cnes.sirius.patrius.forces.EmpiricalForce
Simple constructor for an empiric force using Parameter for A; B and C coef with a given frame.
EmpiricalForce(int, Vector3D, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, LOFType) - Constructor for class fr.cnes.sirius.patrius.forces.EmpiricalForce
Simple constructor for an empiric force using parameterizable functions for A; B and C coef with a given LOF frame.
EmpiricalForce(int, Vector3D, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, IParamDiffFunction, Frame) - Constructor for class fr.cnes.sirius.patrius.forces.EmpiricalForce
Simple constructor for an empiric force using parameterizable functions for A; B and C coef with a given frame.
end() - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
End visiting a matrix.
end() - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
End visiting a matrix.
end() - Method in class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
End visiting a matrix.
end() - Method in class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.FieldMatrixChangingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.FieldMatrixPreservingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.RealMatrixChangingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.RealMatrixPreservingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math3.linear.RealVectorChangingVisitor
End visiting a vector.
end() - Method in interface org.apache.commons.math3.linear.RealVectorPreservingVisitor
End visiting a vector.
endRun() - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
endRun Making results file at the end of run
entrySetIterator() - Method in class org.apache.commons.math3.stat.Frequency
Return an Iterator over the set of keys and values that have been added.
EnumLineProperty - Enum in fr.cnes.sirius.patrius.projections
This enumeration allows user to know how polygon's points are connected.
EnumPolygon - Enum in org.apache.commons.math3.geometry.euclidean.twod
Define the type of 2D polygon
EO - Static variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
81 days
EODProvider - Class in org.orekit.frames.transformations
TransformProvider for FramesFactory.getEODFrame(boolean).
EODProvider() - Constructor for class org.orekit.frames.transformations.EODProvider
Public constructor.
EOP05C04FilesLoader - Class in org.orekit.frames.configuration.eop
Loader for EOP 05 C04 files.
EOP05C04FilesLoader(String) - Constructor for class org.orekit.frames.configuration.eop.EOP05C04FilesLoader
Build a loader for IERS EOP 05 C04 files.
EOP08C04FilesLoader - Class in org.orekit.frames.configuration.eop
Loader for EOP 08 C04 files.
EOP08C04FilesLoader(String) - Constructor for class org.orekit.frames.configuration.eop.EOP08C04FilesLoader
Build a loader for IERS EOP 08 C04 files.
EOP1980Entry - Class in org.orekit.frames.configuration.eop
This class holds an Earth Orientation Parameters entry (IAU1980).
EOP1980Entry(int, double, double, double, double, double, double, EOPEntry.DtType) - Constructor for class org.orekit.frames.configuration.eop.EOP1980Entry
Simple constructor.
EOP1980Entry(DateComponents, double, double, double, double, double, double, EOPEntry.DtType) - Constructor for class org.orekit.frames.configuration.eop.EOP1980Entry
Constructor with DateComponents parameter.
EOP1980Entry(AbsoluteDate, double, double, double, double, double, double, EOPEntry.DtType) - Constructor for class org.orekit.frames.configuration.eop.EOP1980Entry
Constructor with an AbsoluteDate parameter.
EOP1980Entry(int, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.eop.EOP1980Entry
Simple constructor.
EOP1980Entry(DateComponents, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.eop.EOP1980Entry
Constructor with DateComponents parameter.
EOP1980Entry(AbsoluteDate, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.eop.EOP1980Entry
Constructor with an AbsoluteDate parameter.
EOP1980History - Class in org.orekit.frames.configuration.eop
This class holds Earth Orientation Parameters (IAU1980) data throughout a large time range.
EOP1980History(EOPInterpolators) - Constructor for class org.orekit.frames.configuration.eop.EOP1980History
Simple constructor.
EOP1980HistoryLoader - Interface in org.orekit.frames.configuration.eop
Interface for loading Earth Orientation Parameters 1980 history.
EOP2000Entry - Class in org.orekit.frames.configuration.eop
This class holds an Earth Orientation Parameters entry (IAU2000).
EOP2000Entry(int, double, double, double, double, double, double, EOPEntry.DtType) - Constructor for class org.orekit.frames.configuration.eop.EOP2000Entry
Simple constructor.
EOP2000Entry(DateComponents, double, double, double, double, double, double, EOPEntry.DtType) - Constructor for class org.orekit.frames.configuration.eop.EOP2000Entry
Constructor with DateComponents parameter.
EOP2000Entry(AbsoluteDate, double, double, double, double, double, double, EOPEntry.DtType) - Constructor for class org.orekit.frames.configuration.eop.EOP2000Entry
Constructor with an AbsoluteDate parameter.
EOP2000Entry(int, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.eop.EOP2000Entry
Simple constructor.
EOP2000Entry(DateComponents, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.eop.EOP2000Entry
Constructor with DateComponents parameter.
EOP2000Entry(AbsoluteDate, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.eop.EOP2000Entry
Constructor with an AbsoluteDate parameter.
EOP2000History - Class in org.orekit.frames.configuration.eop
This class holds Earth Orientation Parameters (IAU2000) data throughout a large time range.
EOP2000History(EOPInterpolators) - Constructor for class org.orekit.frames.configuration.eop.EOP2000History
Simple constructor.
EOP2000HistoryConstantOutsideInterval - Class in org.orekit.frames.configuration.eop
This class extends the EOP data outside of the historic definition interval.
EOP2000HistoryConstantOutsideInterval(EOPInterpolators) - Constructor for class org.orekit.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
Constructor.
EOP2000HistoryLoader - Interface in org.orekit.frames.configuration.eop
Interface for loading Earth Orientation Parameters 2000 history.
EOPC04_1980_FILENAME - Static variable in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Default regular expression for the EOPC04 files (IAU1980 compatibles).
EOPC04_2000_FILENAME - Static variable in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Default regular expression for the EOPC04 files (IAU2000 compatibles).
EOPEntry - Class in org.orekit.frames.configuration.eop
This class holds an Earth Orientation Parameters entry.
EOPEntry(int, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.eop.EOPEntry
Simple constructor.
EOPEntry(DateComponents, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.eop.EOPEntry
Constructor with DateComponents parameter.
EOPEntry(AbsoluteDate, double, double, double, double, double, double) - Constructor for class org.orekit.frames.configuration.eop.EOPEntry
Constructor with an AbsoluteDate parameter.
EOPEntry(int, double, double, double, double, double, double, EOPEntry.DtType) - Constructor for class org.orekit.frames.configuration.eop.EOPEntry
Simple constructor.
EOPEntry(DateComponents, double, double, double, double, double, double, EOPEntry.DtType) - Constructor for class org.orekit.frames.configuration.eop.EOPEntry
Constructor with DateComponents parameter.
EOPEntry(AbsoluteDate, double, double, double, double, double, double, EOPEntry.DtType) - Constructor for class org.orekit.frames.configuration.eop.EOPEntry
Constructor with an AbsoluteDate parameter.
EOPEntry.DtType - Enum in org.orekit.frames.configuration.eop
dt type.
EOPHistory - Interface in org.orekit.frames.configuration.eop
Interface for retrieving Earth Orientation Parameters history throughout a large time range.
EOPHistoryFactory - Class in org.orekit.frames.configuration.eop
Factory for EOPHistory.
EOPInterpolators - Enum in org.orekit.frames.configuration.eop
This enumerate lists available interpolators for EOP data.
Ephemeris - Class in org.orekit.propagation.precomputed
This class is designed to accept and handle tabulated orbital entries.
Ephemeris(List<SpacecraftState>, int) - Constructor for class org.orekit.propagation.precomputed.Ephemeris
Constructor with tabulated states.
EPHEMERIS_GENERATION_MODE - Static variable in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Indicator for ephemeris generation mode.
EPHEMERIS_GENERATION_MODE - Static variable in interface org.orekit.propagation.Propagator
Indicator for ephemeris generation mode.
EphemerisBody - Enum in fr.cnes.sirius.validate.mocks.ephemeris
Class implementing the IEphemerisBody interface with the implementation of the methods returning the attraction coefficient and the definition for the IAU pole.
EphemerisComparator - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class provides the global usage of the ephemeris comparator library.
EphemerisComparator() - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
Simple constructor
EphemerisComparatorException - Exception in fr.cnes.sirius.patrius.tools.exception
The exception is specific to the ephemeris comparator.
EphemerisComparatorException(Localizable) - Constructor for exception fr.cnes.sirius.patrius.tools.exception.EphemerisComparatorException
Simple constructor.
EphemerisComparatorException(Localizable, Throwable) - Constructor for exception fr.cnes.sirius.patrius.tools.exception.EphemerisComparatorException
Simple constructor.
EphemerisComparatorMain - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
- main of ephemeris comparator
EphemerisComparatorRuntimeException - Exception in fr.cnes.sirius.patrius.tools.exception
The exception is specific to the ephemeris comparator.
EphemerisComparatorRuntimeException(Localizable) - Constructor for exception fr.cnes.sirius.patrius.tools.exception.EphemerisComparatorRuntimeException
Simple constructor.
EphemerisComparatorRuntimeException(Localizable, Throwable) - Constructor for exception fr.cnes.sirius.patrius.tools.exception.EphemerisComparatorRuntimeException
Simple constructor.
EphemerisPvHermite - Class in org.orekit.utils
This class extends AbstractBoundedPVProvider which implements PVCoordinatesProvider and so provides a position velocity for a given date.
EphemerisPvHermite(PVCoordinates[], Vector3D[], Frame, AbsoluteDate[], ISearchIndex) - Constructor for class org.orekit.utils.EphemerisPvHermite
Creates an instance of EphemerisPvHermite.
EphemerisPvHermite(SpacecraftState[], Vector3D[], ISearchIndex) - Constructor for class org.orekit.utils.EphemerisPvHermite
Creates an instance of EphemerisPvHermite from a SpacecraftState table
EphemerisPvLagrange - Class in org.orekit.utils
This class extends AbstractBoundedPVProvider which implements PVCoordinatesProvider and so provides a position velocity for a given date.
EphemerisPvLagrange(PVCoordinates[], int, Frame, AbsoluteDate[], ISearchIndex) - Constructor for class org.orekit.utils.EphemerisPvLagrange
Creates an instance of EphemerisPvLagrange
EphemerisPvLagrange(SpacecraftState[], int, ISearchIndex) - Constructor for class org.orekit.utils.EphemerisPvLagrange
Creates an instance of EphemerisPvLagrange from a spacecraftstate list
EPS - Static variable in class org.orekit.orbits.orbitalparameters.ReentryParameters
Epsilon for specific cases.
EPSILON - Static variable in class fr.cnes.sirius.patrius.UtilsPatrius
Smallest positive number such that 1 - EPSILON is not numerically equal to 1.
EPSILON - Static variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Numerical precision.
EPSILON - Static variable in class org.apache.commons.math3.util.Precision
Largest double-precision floating-point number such that 1 + EPSILON is numerically equal to 1.
EPSILON - Static variable in class org.apache.commons.math3.UtilsCommonsMath
Smallest positive number such that 1 - EPSILON is not numerically equal to 1.
equal(double, double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Tests the equality of two angles after expressing them in the same interval.
equals(Object) - Method in class fr.cnes.sirius.patrius.events.CodedEvent
Checks if the instance represents the same CodedEvent as another instance.
equals(Object) - Method in class fr.cnes.sirius.patrius.events.Phenomenon
Checks if the instance represents the same Phenomenon as another instance.
equals(double, double) - Static method in class fr.cnes.sirius.patrius.utils.Comparators
Tests the equality between doubles with a relative comparison using a default epsilon.
equals(double, double, double) - Static method in class fr.cnes.sirius.patrius.utils.Comparators
Tests the equality between doubles with a relative comparison using an input epsilon.
equals(Object) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Test for the equality of two derivative structures.
equals(Object) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
equals(Object) - Method in class org.apache.commons.math3.complex.Complex
Test for the equality of two Complex objects.
equals(Object) - Method in class org.apache.commons.math3.complex.Quaternion
equals(Quaternion, double) - Method in class org.apache.commons.math3.complex.Quaternion
Checks whether this instance is equal to another quaternion within a given tolerance.
equals(Object) - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is equal to x.
equals(Object) - Method in class org.apache.commons.math3.fraction.BigFraction
Test for the equality of two fractions.
equals(Object) - Method in class org.apache.commons.math3.fraction.Fraction
Test for the equality of two fractions.
equals(Object) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Test for the equality of two 1D vectors.
equals(Object) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Test for the equality of two 3D vectors.
equals(Object) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Asserts two Matrix3D to be equal.
equals(Object) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Test for the equality of two 3D vectors.
equals(Object) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Test for the equality of two 2D vectors.
equals(Object) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
equals(Object) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns true iff object is a FieldMatrix instance with the same dimensions as this and all corresponding matrix entries are equal.
equals(Object) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns true iff object is a RealMatrix instance with the same dimensions as this and all corresponding matrix entries are equal.
equals(Object) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Test for the equality of two vectors.
equals(Object) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Test for the equality of two real vectors.
equals(Object) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated.  Test for the equality of two real vectors.
equals(Object) - Method in class org.apache.commons.math3.linear.RealVector
Test for the equality of two real vectors.
equals(Object) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. 
equals(Object) - Method in class org.apache.commons.math3.optim.linear.LinearConstraint
 
equals(Object) - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
 
equals(Object) - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.  
equals(Object) - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.  
equals(Object) - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
equals(Object) - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns true iff object is an AbstractStorelessUnivariateStatistic returning the same values as this for getResult() and getN()
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns true iff object is a MultivariateSummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
Returns true iff object is a StatisticalSummaryValues instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns true iff object is a SummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns true iff object is a MultivariateSummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns true iff object is a SummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math3.stat.Frequency
equals(Object) - Method in class org.apache.commons.math3.util.BigReal
equals(Object) - Method in class org.apache.commons.math3.util.Decimal64
equals(Object) - Method in class org.apache.commons.math3.util.DefaultTransformer
equals(float[], float[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by Precision.equals(float,float).
equals(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by Precision.equals(double,double).
equals(Object) - Method in class org.apache.commons.math3.util.Pair
Compare the specified object with this entry for equality.
equals(float, float) - Static method in class org.apache.commons.math3.util.Precision
Returns true iff they are equal as defined by equals(x, y, 1).
equals(float, float, float) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are equal or within the range of allowed error (inclusive).
equals(float, float, int) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are equal or within the range of allowed error (inclusive).
equals(double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true iff they are equal as defined by equals(x, y, 1).
equals(double, double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true if there is no double value strictly between the arguments or the difference between them is within the range of allowed error (inclusive).
equals(double, double, int) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are equal or within the range of allowed error (inclusive).
equals(Object) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns true iff object is a ResizableDoubleArray with the same properties as this and an identical internal storage array.
equals(Object) - Method in class org.apache.commons.math3.util.TransformerMap
equals(Object) - Method in class org.orekit.time.AbsoluteDate
Check if the instance represent the same time as another instance.
equals(Object) - Method in class org.orekit.time.DateComponents
equals(Object) - Method in class org.orekit.time.DateTimeComponents
equals(Object) - Method in class org.orekit.time.TimeComponents
equals(Object) - Method in class org.orekit.utils.ComparableInterval
Checks if the instance represents the same ComparableInterval as another instance.
equalsAddStates(Map<String, double[]>, Map<String, double[]>) - Static method in class org.orekit.propagation.SpacecraftState
Compares additional states.
equalsIncludingNaN(float[], float[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by this method.
equalsIncludingNaN(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by this method.
equalsIncludingNaN(float, float) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are NaN or neither is NaN and they are equal as defined by equals(x, y, 1).
equalsIncludingNaN(float, float, float) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are NaN or are equal or within the range of allowed error (inclusive).
equalsIncludingNaN(float, float, int) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are NaN or if they are equal as defined by equals(x, y, maxUlps).
equalsIncludingNaN(double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are NaN or neither is NaN and they are equal as defined by equals(x, y, 1).
equalsIncludingNaN(double, double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are NaN or are equal or within the range of allowed error (inclusive).
equalsIncludingNaN(double, double, int) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are NaN or if they are equal as defined by equals(x, y, maxUlps).
equalsWithRelativeTolerance(double, double, double) - Static method in class fr.cnes.sirius.patrius.utils.Comparators
Copied from commons math Precision.equalsWithRelativeTolerance(double, double, double).
equalsWithRelativeTolerance(double, double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true if there is no double value strictly between the arguments or the reltaive difference between them is smaller or equal to the given tolerance.
equalsWithRelativeTolerance(double, double) - Static method in class org.apache.commons.math3.util.Precision
Returns true if both arguments are found equal with a relative comparison using a default epsilon.
EquationsMapper - Class in org.apache.commons.math3.ode
Class mapping the part of a complete state or derivative that pertains to a specific differential equation.
EquationsMapper(int, int) - Constructor for class org.apache.commons.math3.ode.EquationsMapper
simple constructor.
EquatorialOrbit - Class in org.orekit.orbits
This class handles non circular equatorial orbital parameters.
EquatorialOrbit(IOrbitalParameters, Frame, AbsoluteDate) - Constructor for class org.orekit.orbits.EquatorialOrbit
Creates a new instance.
EquatorialOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.EquatorialOrbit
Creates a new instance.
EquatorialOrbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.EquatorialOrbit
Constructor from cartesian parameters.
EquatorialOrbit(Orbit) - Constructor for class org.orekit.orbits.EquatorialOrbit
Constructor from any kind of orbital parameters.
EquatorialParameters - Class in org.orekit.orbits.orbitalparameters
This class handles non circular equatorial orbital parameters.
EquatorialParameters(double, double, double, double, double, double, PositionAngle, double) - Constructor for class org.orekit.orbits.orbitalparameters.EquatorialParameters
Creates a new instance.
EquinoctialOrbit - Class in org.orekit.orbits
This class handles equinoctial orbital parameters, which can support both circular and equatorial orbits.
EquinoctialOrbit(IOrbitalParameters, Frame, AbsoluteDate) - Constructor for class org.orekit.orbits.EquinoctialOrbit
Creates a new instance.
EquinoctialOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.EquinoctialOrbit
Creates a new instance.
EquinoctialOrbit(double, double, double, double, double, double, int, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.EquinoctialOrbit
Deprecated. as of 6.0 replaced by EquinoctialOrbit.EquinoctialOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double)
EquinoctialOrbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.EquinoctialOrbit
Constructor from cartesian parameters.
EquinoctialOrbit(Orbit) - Constructor for class org.orekit.orbits.EquinoctialOrbit
Constructor from any kind of orbital parameters.
EquinoctialParameters - Class in org.orekit.orbits.orbitalparameters
This class handles equinoctial orbital parameters, which can support both circular and equatorial orbits.
EquinoctialParameters(double, double, double, double, double, double, PositionAngle, double) - Constructor for class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Creates a new instance.
Erf - Class in org.apache.commons.math3.special
This is a utility class that provides computation methods related to the error functions.
erf(double) - Static method in class org.apache.commons.math3.special.Erf
Returns the error function.
erf(double, double) - Static method in class org.apache.commons.math3.special.Erf
Returns the difference between erf(x1) and erf(x2).
erfc(double) - Static method in class org.apache.commons.math3.special.Erf
Returns the complementary error function.
ERR_SCALE - Static variable in class org.apache.commons.math3.dfp.Dfp
The amount under/overflows are scaled by before going to trap handler
estimateError(double[][], double[], double[], double) - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
Compute the error ratio.
estimateError(double[][], double[], double[], double) - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
Compute the error ratio.
estimateError(double[][], double[], double[], double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Compute the error ratio.
estimateError(double[][], double[], double[], double) - Method in class org.apache.commons.math3.ode.nonstiff.HighamHall54Integrator
Compute the error ratio.
estimateErrorVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the variance of the error.
estimateRate(AbsoluteDate, double) - Method in class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Estimate the spin at a given date from the current OrientationFunction using the AngularCoordinates.estimateRate(Rotation, Rotation, double) method.
estimateRate(Rotation, Rotation, double) - Static method in class org.orekit.utils.AngularCoordinates
Estimate rotation rate between two orientations.
estimateRateFunction(double) - Method in class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Estimate the Vector3DFunction from the current OrientationFunction using the AngularCoordinates.estimateRate(Rotation, Rotation, double) method.
estimateRateFunction(double) - Method in interface org.orekit.attitudes.kinematics.OrientationFunction
Estimate the Vector3DFunction from the current OrientationFunction using the AngularCoordinates.estimateRate(Rotation, Rotation, double) method.
estimateRegressandVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Returns the variance of the regressand, ie Var(y).
estimateRegressandVariance() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Returns the variance of the regressand, ie Var(y).
estimateRegressionParameters() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the regression parameters b.
estimateRegressionParameters() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Estimates the regression parameters b.
estimateRegressionParametersStandardErrors() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Returns the standard errors of the regression parameters.
estimateRegressionParametersStandardErrors() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Returns the standard errors of the regression parameters.
estimateRegressionParametersVariance() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the variance of the regression parameters, ie Var(b).
estimateRegressionParametersVariance() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Estimates the variance of the regression parameters, ie Var(b).
estimateRegressionStandardError() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the standard error of the regression.
estimateResiduals() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Estimates the residuals, ie u = y - X*b.
estimateResiduals() - Method in interface org.apache.commons.math3.stat.regression.MultipleLinearRegression
Estimates the residuals, ie u = y - X*b.
estimateSpin(Rotation, Rotation, double) - Static method in class org.orekit.attitudes.Attitude
Deprecated. as of 6.0 superseded by AngularCoordinates.estimateRate(Rotation, Rotation, double)
estimateSpin(Rotation, Rotation, double) - Static method in class org.orekit.attitudes.kinematics.KinematicsToolkit
Estimate spin between two orientations.
Estimation is based on a simple fixed rate rotation during the time interval between the two attitude.
estimateVelocity(Vector3D, Vector3D, double) - Static method in class org.orekit.utils.PVCoordinates
Estimate velocity between two positions.
eta - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
eta from SPTRCK #3.
etasq - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
eta squared.
Euclidean1D - Class in org.apache.commons.math3.geometry.euclidean.oned
This class implements a one-dimensional space.
Euclidean2D - Class in org.apache.commons.math3.geometry.euclidean.twod
This class implements a three-dimensional space.
Euclidean3D - Class in org.apache.commons.math3.geometry.euclidean.threed
This class implements a three-dimensional space.
EuclideanDoublePoint - Class in org.apache.commons.math3.stat.clustering
A simple implementation of Clusterable for points with double coordinates.
EuclideanDoublePoint(double[]) - Constructor for class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Build an instance wrapping an integer array.
EuclideanIntegerPoint - Class in org.apache.commons.math3.stat.clustering
A simple implementation of Clusterable for points with integer coordinates.
EuclideanIntegerPoint(int[]) - Constructor for class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Build an instance wrapping an integer array.
EulerIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements a simple Euler integrator for Ordinary Differential Equations.
EulerIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.EulerIntegrator
Simple constructor.
evaluate(FourierSeries, double) - Static method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Compute value at x of trigonometric polynomial P :
P(x) = a0 + a(k) * cos(kx) + b(k) * sin(kx)
evaluate(double[], double) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Uses Horner's Method to evaluate the polynomial with the given coefficients at the argument.
evaluate(double[], double[], double) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Evaluate the Lagrange polynomial using Neville's Algorithm.
evaluate(double[], double[], double) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Evaluate the Newton polynomial using nested multiplication.
evaluate(TrigonometricPolynomialFunction, double) - Static method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Compute value at x of trigonometric polynomial P :
P(x) = a0 + a(k) * cos(kx) + b(k) * sin(kx)
evaluate(TrigonometricPolynomialPrimitive, double) - Static method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Static evaluation method
evaluate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Evaluate all the non-evaluated points of the simplex.
evaluate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Evaluate all the non-evaluated points of the simplex.
evaluate(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation calls AbstractStorelessUnivariateStatistic.clear(), then invokes AbstractStorelessUnivariateStatistic.increment(double) in a loop over the the input array, and then uses AbstractStorelessUnivariateStatistic.getResult() to compute the return value.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation calls AbstractStorelessUnivariateStatistic.clear(), then invokes AbstractStorelessUnivariateStatistic.increment(double) in a loop over the specified portion of the input array, and then uses AbstractStorelessUnivariateStatistic.getResult() to compute the return value.
evaluate() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Returns the result of evaluating the statistic over the stored data.
evaluate(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Returns the result of evaluating the statistic over the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Returns the result of evaluating the statistic over the specified entries in the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns the geometric mean of the entries in the specified portion of the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Returns the kurtosis of the entries in the specified portion of the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the weighted arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the weighted arithmetic mean of the entries in the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the mean, using instance properties varianceDirection and biasCorrection.
evaluate(double[], SemiVariance.Direction) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
This method calculates SemiVariance for the entire array against the mean, using the current value of the biasCorrection instance property.
evaluate(double[], double) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the cutoff, using instance properties variancDirection and biasCorrection.
evaluate(double[], double, SemiVariance.Direction) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the cutoff in the given direction, using the current value of the biasCorrection instance property.
evaluate(double[], double, SemiVariance.Direction, boolean, int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the cutoff in the given direction with the provided bias correction.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Returns the Skewness of the entries in the specifed portion of the input array.
evaluate(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the input array, or Double.NaN if the array is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double, int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the specified portion of the input array, using the precomputed mean value.
evaluate(double[], double) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the input array, using the precomputed mean value.
evaluate(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the variance of the entries in the input array, or Double.NaN if the array is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the weighted variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the weighted variance of the entries in the the input array.
evaluate(double[], double, int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
evaluate(double[], double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the variance of the entries in the input array, using the precomputed mean value.
evaluate(double[], double[], double, int, int) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the weighted variance of the entries in the specified portion of the input array, using the precomputed weighted mean value.
evaluate(double[], double[], double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the weighted variance of the values in the input array, using the precomputed weighted mean value.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Returns the maximum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Returns the minimum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns the result of evaluating the statistic over the stored data.
evaluate(double[]) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns an estimate of the quantileth percentile of the values array.
evaluate(double[], double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns an estimate of the pth percentile of the values in the values array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns an estimate of the quantileth percentile of the designated values in the values array.
evaluate(double[], int, int, double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Returns an estimate of the pth percentile of the values in the values array, starting with the element in (0-based) position begin in the array and including length values.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the weighted product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the weighted product of the entries in the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
The sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
The weighted sum of the entries in the specified portion of the input array, or 0 if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
The weighted sum of the entries in the the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
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.
evaluate(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
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.
evaluate(double[]) - Method in interface org.apache.commons.math3.stat.descriptive.UnivariateStatistic
Returns the result of evaluating the statistic over the input array.
evaluate(double[], int, int) - Method in interface org.apache.commons.math3.stat.descriptive.UnivariateStatistic
Returns the result of evaluating the statistic over the specified entries in the input array.
evaluate(double[], double[]) - Method in interface org.apache.commons.math3.stat.descriptive.WeightedEvaluation
Returns the result of evaluating the statistic over the input array, using the supplied weights.
evaluate(double[], double[], int, int) - Method in interface org.apache.commons.math3.stat.descriptive.WeightedEvaluation
Returns the result of evaluating the statistic over the specified entries in the input array, using corresponding entries in the supplied weights array.
evaluate(double) - Method in class org.apache.commons.math3.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, double) - Method in class org.apache.commons.math3.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, int) - Method in class org.apache.commons.math3.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, double, int) - Method in class org.apache.commons.math3.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double[]) - Method in interface org.apache.commons.math3.util.MathArrays.Function
Operates on an entire array.
evaluate(double[], int, int) - Method in interface org.apache.commons.math3.util.MathArrays.Function
 
evaluateStep(double, double[]) - Method in class org.apache.commons.math3.ode.events.EventState
Evaluate the impact of the proposed step on the event handler.
evaluateStep(StepInterpolator) - Method in class org.apache.commons.math3.ode.events.EventState
Evaluate the impact of the proposed step on the event handler.
evaluateStep(SpacecraftState) - Method in class org.orekit.propagation.events.EventState
Evaluate the impact of the proposed step on the event handler.
evaluateStep(OrekitStepInterpolator) - Method in class org.orekit.propagation.events.EventState
Evaluate the impact of the proposed step on the event detector.
See Orekit issue 110 for more information.
evaluations - Variable in class org.apache.commons.math3.optim.BaseOptimizer
Evaluations counter.
evaluations - Variable in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. Evaluations counter.
evaluations - Variable in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Evaluations counter.
EventDetector - Interface in org.orekit.propagation.events
This interface represents space-dynamics aware events detectors with support for additional states.
EventDetector.Action - Enum in org.orekit.propagation.events
Enumerate for actions to be performed when an event occurs.
EventHandler - Interface in org.apache.commons.math3.ode.events
This interface represents a handler for discrete events triggered during ODE integration.
EventHandler.Action - Enum in org.apache.commons.math3.ode.events
Enumerate for actions to be performed when an event occurs.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.CentralBodyMaskCircularFOVDetector
Handle a target in field of view outside eclipse reaching event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.CombinedPhenomenaDetector
Handle an event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.EarthZoneDetector
Handle the event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
eventOccurred(Map<String, SpacecraftState>, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Handle an event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Handle "masking" event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.RFVisibilityDetector
 
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
 
eventOccurred(Map<String, SpacecraftState>, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
 
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.SensorInhibitionDetector
 
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
 
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.StationToSatMutualVisibilityDetector
 
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
 
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
Handle "visibility from station" event and choose what to do next.
eventOccurred(double, double[], boolean, boolean) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMonoEventDetector
 
eventOccurred(double, double[], boolean, boolean) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMultiEventDetector
 
eventOccurred(Map<String, SpacecraftState>, boolean, boolean) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
 
eventOccurred(Map<String, SpacecraftState>, boolean, boolean) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.OneSatEventDetectorWrapper
 
eventOccurred(SpacecraftState, boolean, boolean) - Method in class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Handle an altitude event and choose what to do next.
eventOccurred(double, double[], boolean, boolean) - Method in interface org.apache.commons.math3.ode.events.EventHandler
Handle an event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Handle an event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.AbstractDetector
Handle an event and choose what to do next.
eventOccurred(double, double[], boolean, boolean) - Method in class org.orekit.propagation.events.AdaptedEventDetector
Handle an event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.AlignmentDetector
Handle an alignment event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.AltitudeDetector
Handle an altitude event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.AnomalyDetector
Handle an anomaly event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.AOLDetector
Handle an AOL event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.ApparentElevationDetector
Handle an apparent elevation event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.ApsideDetector
Handle an apside crossing event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.BetaAngleDetector
Handles a beta angle event and chooses what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.CircularFieldOfViewDetector
Handle an fov event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.DateDetector
Handle a date event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.DihedralFieldOfViewDetector
Handle an fov event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.DistanceDetector
Handle a distance event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.EclipseDetector
Handle an eclipse event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.ElevationDetector
Handle an elevation event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in interface org.orekit.propagation.events.EventDetector
Handle an event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.EventShifter
Handle an event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.ExtremaDistanceDetector
Handle an extrema distance event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.ExtremaElevationDetector
Handle an extrema distance event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.ExtremaLatitudeDetector
Handle an extrema latitude event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.ExtremaLongitudeDetector
Handle an extrema distance event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Handle a min or max angle event and choose what to do next.
eventOccurred(Map<String, SpacecraftState>, boolean, boolean) - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
 
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.GroundMaskElevationDetector
Handle an azimuth-elevation event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.LatitudeDetector
Handle a latitude reaching event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.LocalTimeDetector
Handle a local time event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.LongitudeDetector
Handle a longitude reaching event and choose what to do next.
eventOccurred(Map<String, SpacecraftState>, boolean, boolean) - Method in interface org.orekit.propagation.events.multi.MultiEventDetector
Handle an event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.NadirSolarIncidenceDetector
Handle a solar incidence event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.NodeDetector
Handle a node crossing event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Handle an event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.NullMassDetector
If the global mass of the satellite becomes negative, the propagation is stopped.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.NullMassPartDetector
If the mass of the element becomes negative, a reset_state is performed.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.SolarTimeDetector
Handle a solar time event and choose what to do next.
eventOccurred(SpacecraftState, boolean, boolean) - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
Handle an angle event and choose what to do next.
eventOccurred(Map<String, SpacecraftState>, boolean, boolean) - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
 
EventsDuringPhenomenaFilter - Class in fr.cnes.sirius.patrius.events.postprocessing
 
EventsDuringPhenomenaFilter(String, String, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.EventsDuringPhenomenaFilter
Constructor
EventsDuringPhenomenaFilter(List<String>, String, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.EventsDuringPhenomenaFilter
Constructor
EventShifter - Class in org.orekit.propagation.events
Wrapper shifting events occurrences times.
EventShifter(EventDetector, boolean, double, double) - Constructor for class org.orekit.propagation.events.EventShifter
Build a new instance.
EventsLogger - Class in org.orekit.propagation.events
This class logs events detectors events during propagation.
EventsLogger() - Constructor for class org.orekit.propagation.events.EventsLogger
Simple constructor.
EventsLogger.LoggedEvent - Class in org.orekit.propagation.events
Class for logged events entries.
eventsStates - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Event steps.
EventState - Class in org.apache.commons.math3.ode.events
This class handles the state for one event handler during integration steps.
EventState(EventHandler, double, double, int, UnivariateSolver) - Constructor for class org.apache.commons.math3.ode.events.EventState
Simple constructor.
EventState - Class in org.orekit.propagation.events
This class handles the state for one event detector during integration steps.
EventState(EventDetector, UnivariateSolver) - Constructor for class org.orekit.propagation.events.EventState
Constructor allowing the user to provide the solver used in switch detection.
EventState(EventDetector) - Constructor for class org.orekit.propagation.events.EventState
Simple constructor.
evolve(Population, StoppingCondition) - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Evolve the given population.
exactLog2(int) - Static method in class org.apache.commons.math3.transform.TransformUtils
Returns the base-2 logarithm of the specified int.
ExceptionContext - Class in org.apache.commons.math3.exception.util
Class that contains the actual implementation of the functionality mandated by the ExceptionContext interface.
ExceptionContext(Throwable) - Constructor for class org.apache.commons.math3.exception.util.ExceptionContext
Simple constructor.
ExceptionContextProvider - Interface in org.apache.commons.math3.exception.util
Interface for accessing the context data structure stored in Commons Math exceptions.
exp() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Exponential.
exp(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute exponential of a derivative structure.
Exp - Class in org.apache.commons.math3.analysis.function
Exponential function.
Exp() - Constructor for class org.apache.commons.math3.analysis.function.Exp
 
exp() - Method in class org.apache.commons.math3.complex.Complex
Compute the exponential function of this complex number.
exp - Variable in class org.apache.commons.math3.dfp.Dfp
Exponent.
exp(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
Computes e to the given power.
exp() - Method in interface org.apache.commons.math3.RealFieldElement
Exponential.
exp(double) - Static method in class org.apache.commons.math3.util.FastMath
Exponential function.
expand() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Expands the internal storage array using the expansion factor.
ExpandableStatefulODE - Class in org.apache.commons.math3.ode
This class represents a combined set of first order differential equations, with at least a primary set of equations expandable by some sets of secondary equations.
ExpandableStatefulODE(FirstOrderDifferentialEquations) - Constructor for class org.apache.commons.math3.ode.ExpandableStatefulODE
Build an expandable set from its primary ODE set.
expInternal(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
Computes e to the given power.
expm1() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Exponential minus 1.
expm1(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute exp(x) - 1 of a derivative structure.
Expm1 - Class in org.apache.commons.math3.analysis.function
ex-1 function.
Expm1() - Constructor for class org.apache.commons.math3.analysis.function.Expm1
 
expm1() - Method in interface org.apache.commons.math3.RealFieldElement
Exponential minus 1.
expm1(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute exp(x) - 1
EXPONENTIAL_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Exponential random deviates with mean = μ.
ExponentialDistribution - Class in org.apache.commons.math3.distribution
Implementation of the exponential distribution.
ExponentialDistribution(double) - Constructor for class org.apache.commons.math3.distribution.ExponentialDistribution
Create an exponential distribution with the given mean.
ExponentialDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.ExponentialDistribution
Create an exponential distribution with the given mean.
ExponentialDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.ExponentialDistribution
Creates an exponential distribution.
ExtendedOneAxisEllipsoid - Class in org.orekit.bodies
implementation of the PatriusBodyShape interface : this an extended spheroid model to represent celestial bodies shapes.
ExtendedOneAxisEllipsoid(double, double, Frame, String) - Constructor for class org.orekit.bodies.ExtendedOneAxisEllipsoid
Constructor for the body spheroid.
ExtendedSolarActivityWrapper - Class in org.orekit.forces.atmospheres.solarActivity
This class is a solar activity data provider fed with: a user-defined SolarActivityDataProvider A averaged duration d It is built with the following convention: It returns solar activity from user-provided solar activity data provider if date is within timespan of the user-provided solar activity data provider. It returns an average of first available solar data over user-defined period d if date is before lower boundary of the user-provided solar activity data provider. It returns an average of last available solar data over user-defined period d if date is after upper boundary of the user-provided solar activity data provider.
ExtendedSolarActivityWrapper(SolarActivityDataProvider, double) - Constructor for class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Constructor.
extractData(int[]) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Data
Extracts several columns from this Data object and produces a Data object from them.
extractEquationData(double[], double[]) - Method in class org.apache.commons.math3.ode.EquationsMapper
Extract equation data from a complete state or derivative array.
extractField(T[][]) - Static method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the elements type from an array.
extractField(T[]) - Static method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the elements type from an array.
ExtremaDistanceDetector - Class in org.orekit.propagation.events
Detects when the distance from the spacecraft to a given body reaches either a local minimum or a local maximum.
ExtremaDistanceDetector(PVCoordinatesProvider, int) - Constructor for class org.orekit.propagation.events.ExtremaDistanceDetector
Constructor for a ExtremaDistanceDetector instance.
ExtremaDistanceDetector(PVCoordinatesProvider, int, double, double) - Constructor for class org.orekit.propagation.events.ExtremaDistanceDetector
Constructor for a ExtremaDistanceDetector instance with complimentary parameters.
ExtremaDistanceDetector(PVCoordinatesProvider, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaDistanceDetector
Constructor for both minimum and maximum distance .
ExtremaDistanceDetector(PVCoordinatesProvider, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.ExtremaDistanceDetector
Constructor for both minimum and maximum distance .
ExtremaDistanceDetector(PVCoordinatesProvider, int, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaDistanceDetector
Constructor for a ExtremaDistanceDetector instance with specified action when extrema is detected.
ExtremaDistanceDetector(PVCoordinatesProvider, int, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.ExtremaDistanceDetector
Constructor for a ExtremaDistanceDetector instance with specified action when extrema is detected.
ExtremaElevationDetector - Class in org.orekit.propagation.events
Detects the time when the spacecraft reaches the elevation extrema in a given topocentric frame. The local minimum or maximum is chosen through a constructor parameter, with values ExtremaElevationDetector.MIN, ExtremaElevationDetector.MAX and ExtremaElevationDetector.MIN_MAX for both.
ExtremaElevationDetector(TopocentricFrame, int, double) - Constructor for class org.orekit.propagation.events.ExtremaElevationDetector
Constructor for a min and max elevation detector.
ExtremaElevationDetector(TopocentricFrame, int, double, double) - Constructor for class org.orekit.propagation.events.ExtremaElevationDetector
Constructor for a min or max elevation detector.
ExtremaElevationDetector(TopocentricFrame, int, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaElevationDetector
Constructor for a min or max elevation detector.
ExtremaElevationDetector(TopocentricFrame, int, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.ExtremaElevationDetector
Constructor for a min or max elevation detector.
ExtremaLatitudeDetector - Class in org.orekit.propagation.events
Detects when the spacecraft reaches the maximal or minimal local latitude.
ExtremaLatitudeDetector(int, Frame) - Constructor for class org.orekit.propagation.events.ExtremaLatitudeDetector
Constructor for a ExtremaLatitudeDetector instance.
ExtremaLatitudeDetector(int, Frame, double, double) - Constructor for class org.orekit.propagation.events.ExtremaLatitudeDetector
Constructor for a ExtremaLatitudeDetector instance.
ExtremaLatitudeDetector(int, Frame, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaLatitudeDetector
Constructor for a ExtremaLatitudeDetector instance.
ExtremaLatitudeDetector(int, Frame, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.ExtremaLatitudeDetector
Constructor for a ExtremaLatitudeDetector instance.
ExtremaLongitudeDetector - Class in org.orekit.propagation.events
Detects when the spacecraft reaches the maximal or minimal local longitude.
ExtremaLongitudeDetector(int, Frame) - Constructor for class org.orekit.propagation.events.ExtremaLongitudeDetector
Constructor for a ExtremaLongitudeDetector instance.
ExtremaLongitudeDetector(int, Frame, double, double) - Constructor for class org.orekit.propagation.events.ExtremaLongitudeDetector
Constructor for a ExtremaLongitudeDetector instance.
ExtremaLongitudeDetector(int, Frame, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaLongitudeDetector
Constructor for a ExtremaLongitudeDetector instance.
ExtremaLongitudeDetector(int, Frame, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.ExtremaLongitudeDetector
Constructor for a ExtremaLongitudeDetector instance.
ExtremaSightAxisDetector - Class in fr.cnes.sirius.patrius.events.sensor
Detects the minimum angle between a sight view line and a PVCoordinateProvider target view from a Frame which origin is on the line.
ExtremaSightAxisDetector(PVCoordinatesProvider, Vector3D, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor to use without assembly for both minimal and maximal angle detection.
ExtremaSightAxisDetector(PVCoordinatesProvider, Vector3D, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor to use without assembly for both minimal and maximal angle detection.
ExtremaSightAxisDetector(int, PVCoordinatesProvider, Vector3D, double, double, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor to use without assembly.
ExtremaSightAxisDetector(int, PVCoordinatesProvider, Vector3D, double, double, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor to use without assembly.
ExtremaSightAxisDetector(int, PVCoordinatesProvider, Vector3D, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor to use without assembly.
ExtremaSightAxisDetector(int, PVCoordinatesProvider, Vector3D) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor to use without assembly.
ExtremaSightAxisDetector(int, PVCoordinatesProvider, Assembly, String, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor based on an Assembly containing at least one part with sensor property describing the vehicle.
ExtremaSightAxisDetector(int, PVCoordinatesProvider, Assembly, String) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor based on an Assembly containing at least one part with sensor property describing the vehicle.
ExtremaSightAxisDetector(int, PVCoordinatesProvider, Assembly, String, double, double, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor for both minimal and maximal angle based on an Assembly containing at least one part with sensor property describing the vehicle.
ExtremaSightAxisDetector(int, PVCoordinatesProvider, Assembly, String, double, double, EventDetector.Action, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor for both minimal and maximal angle based on an Assembly containing at least one part with sensor property describing the vehicle.
ExtremaSightAxisDetector(PVCoordinatesProvider, Assembly, String, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor for both minimal and maximal angle based on an Assembly containing at least one part with sensor property describing the vehicle.
ExtremaSightAxisDetector(PVCoordinatesProvider, Assembly, String, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Constructor for both minimal and maximal angle based on an Assembly containing at least one part with sensor property describing the vehicle.
ExtremaThreeBodiesAngleDetector - Class in org.orekit.propagation.events
Detects the maximal or minimal angle between three bodies is reached, the spacecraft eventually being one of the bodies.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, PVCoordinatesProvider, int) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, PVCoordinatesProvider, int, double, double) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, PVCoordinatesProvider, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action for both minimum and maximum.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, PVCoordinatesProvider, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action for both minimum and maximum.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, PVCoordinatesProvider, int, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action when extrema is detected.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, PVCoordinatesProvider, int, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action when extrema is detected.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ExtremaThreeBodiesAngleDetector.BodyOrder, int) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Simple constructor for the min and max three bodies angle detector.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ExtremaThreeBodiesAngleDetector.BodyOrder, int, double, double) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with defined maximum check and convergence threshold.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ExtremaThreeBodiesAngleDetector.BodyOrder, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action for both minimum and maximum.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ExtremaThreeBodiesAngleDetector.BodyOrder, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action for both minimum and maximum.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ExtremaThreeBodiesAngleDetector.BodyOrder, int, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action when extrema is detected.
ExtremaThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ExtremaThreeBodiesAngleDetector.BodyOrder, int, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action when extrema is detected.
ExtremaThreeBodiesAngleDetector(String, String, String, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action for both minimum and maximum.
ExtremaThreeBodiesAngleDetector(String, String, String, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action for both minimum and maximum.
ExtremaThreeBodiesAngleDetector(String, String, String, int, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action when extrema is detected.
ExtremaThreeBodiesAngleDetector(String, String, String, int, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Constructor for the min and max three bodies angle detector with specified action when extrema is detected.
ExtremaThreeBodiesAngleDetector.BodyOrder - Enum in org.orekit.propagation.events
Bodies order type.

F

Facet - Class in fr.cnes.sirius.patrius.assembly.properties.features
This class is a cross section provider.
Facet(Vector3D, double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.features.Facet
Simple constructor.
factorial(int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns n!.
factorial(int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Returns n!.
factorialDouble(int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Compute n!, the factorial of n (the product of the numbers 1 to n), as a double.
factorialDouble(int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Compute n!, the factorial of n (the product of the numbers 1 to n), as a double.
factorialLog(int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Compute the natural logarithm of the factorial of n.
factorialLog(int) - Static method in class org.apache.commons.math3.util.CombinatoricsUtils
Compute the natural logarithm of the factorial of n.
FactoryManagedFrame - Class in org.orekit.frames
Base class for the predefined frames that are managed by FramesFactory.
FactoryManagedFrame(Frame, TransformProvider, boolean, Predefined) - Constructor for class org.orekit.frames.FactoryManagedFrame
Simple constructor.
FastCosineTransformer - Class in org.apache.commons.math3.transform
Implements the Fast Cosine Transform for transformation of one-dimensional real data sets.
FastCosineTransformer(DctNormalization) - Constructor for class org.apache.commons.math3.transform.FastCosineTransformer
Creates a new instance of this class, with various normalization conventions.
FastFourierTransformer - Class in org.apache.commons.math3.transform
This class allows the computation of a Fast Fourier Transform for all kind (odd or powers of two) orders.
FastFourierTransformer(DftNormalization) - Constructor for class org.apache.commons.math3.transform.FastFourierTransformer
Constructor of the class FastFourierTransformer, inherited from the one of the abstract class AbstractFastFourierTransformer
FastHadamardTransformer - Class in org.apache.commons.math3.transform
Implements the Fast Hadamard Transform (FHT).
FastHadamardTransformer() - Constructor for class org.apache.commons.math3.transform.FastHadamardTransformer
 
FastMath - Class in org.apache.commons.math3.util
Faster, more accurate, portable alternative to Math and StrictMath for large scale computation.
FastSineTransformer - Class in org.apache.commons.math3.transform
Implements the Fast Sine Transform for transformation of one-dimensional real data sets.
FastSineTransformer(DstNormalization) - Constructor for class org.apache.commons.math3.transform.FastSineTransformer
Creates a new instance of this class, with various normalization conventions.
fct(double[]) - Method in class org.apache.commons.math3.transform.FastCosineTransformer
Perform the FCT algorithm (including inverse).
FDistribution - Class in org.apache.commons.math3.distribution
Implementation of the F-distribution.
FDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.FDistribution
Creates an F distribution using the given degrees of freedom.
FDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.FDistribution
Creates an F distribution using the given degrees of freedom and inverse cumulative probability accuracy.
FDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.FDistribution
Creates an F distribution.
feed(Pattern, DataLoader) - Method in class org.orekit.data.ClasspathCrawler
Feed a data file loader by browsing the data collection.
feed(Pattern, DataLoader) - Method in interface org.orekit.data.DataProvider
Feed a data file loader by browsing the data collection.
feed(String, DataLoader) - Method in class org.orekit.data.DataProvidersManager
Feed a data file loader by browsing all data providers.
feed(Pattern, DataLoader) - Method in class org.orekit.data.DirectoryCrawler
Feed a data file loader by browsing the data collection.
feed(Pattern, DataLoader) - Method in class org.orekit.data.NetworkCrawler
Feed a data file loader by browsing the data collection.
feed(Pattern, DataLoader) - Method in class org.orekit.data.ZipJarCrawler
Feed a data file loader by browsing the data collection.
FES2004_FILENAME - Static variable in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsFactory
Default file name for FES2004
FES2004FormatReader - Class in org.orekit.forces.gravity.tides.coefficients
Reader for FES2004 formats.
FES2004FormatReader(String) - Constructor for class org.orekit.forces.gravity.tides.coefficients.FES2004FormatReader
Constructor
fht(double[]) - Method in class org.apache.commons.math3.transform.FastHadamardTransformer
The FHT (Fast Hadamard Transformation) which uses only subtraction and addition.
fht(int[]) - Method in class org.apache.commons.math3.transform.FastHadamardTransformer
Returns the forward transform of the specified integer data set.
Field<T> - Interface in org.apache.commons.math3
Interface representing a field.
FieldAngularFace - Class in fr.cnes.sirius.patrius.fieldsofview
This class represent a face of a pyramidal field of view.
FieldAngularFace(Vector3D, Vector3D) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.FieldAngularFace
Constructor.
FieldDecompositionSolver<T extends FieldElement<T>> - Interface in org.apache.commons.math3.linear
Interface handling decomposition algorithms that can solve A × X = B.
FieldElement<T> - Interface in org.apache.commons.math3
Interface representing field elements.
FieldLUDecomposition<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Calculates the LUP-decomposition of a square matrix.
FieldLUDecomposition(FieldMatrix<T>) - Constructor for class org.apache.commons.math3.linear.FieldLUDecomposition
Calculates the LU-decomposition of the given matrix.
FieldMatrix<T extends FieldElement<T>> - Interface in org.apache.commons.math3.linear
Interface defining field-valued matrix with basic algebraic operations.
FieldMatrixChangingVisitor<T extends FieldElement<?>> - Interface in org.apache.commons.math3.linear
Interface defining a visitor for matrix entries.
FieldMatrixPreservingVisitor<T extends FieldElement<?>> - Interface in org.apache.commons.math3.linear
Interface defining a visitor for matrix entries.
FieldRotation<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.geometry.euclidean.threed
This class is a re-implementation of Rotation using RealFieldElement.
FieldRotation(T, T, T, T, boolean) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build a rotation from the quaternion coordinates.
FieldRotation(FieldVector3D<T>, T) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build a rotation from an axis and an angle.
FieldRotation(T[][], double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build a rotation from a 3X3 matrix.
FieldRotation(FieldVector3D<T>, FieldVector3D<T>, FieldVector3D<T>, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build the rotation that transforms a pair of vector into another pair.
FieldRotation(FieldVector3D<T>, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build one of the rotations that transform one vector into another one.
FieldRotation(RotationOrder, T, T, T) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Build a rotation from three Cardan or Euler elementary rotations.
FieldVector<T extends FieldElement<T>> - Interface in org.apache.commons.math3.linear
Interface defining a field-valued vector with basic algebraic operations.
FieldVector3D<T extends RealFieldElement<T>> - Class in org.apache.commons.math3.geometry.euclidean.threed
This class is a re-implementation of Vector3D using RealFieldElement.
FieldVector3D(T, T, T) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Simple constructor.
FieldVector3D(T[]) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Simple constructor.
FieldVector3D(T, T) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Simple constructor.
FieldVector3D(T, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiplicative constructor Build a vector from another one and a scale factor.
FieldVector3D(T, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiplicative constructor Build a vector from another one and a scale factor.
FieldVector3D(double, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiplicative constructor Build a vector from another one and a scale factor.
FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
FieldVector3D(T, Vector3D, T, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
FieldVector3D(T, Vector3D, T, Vector3D, T, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
FieldVector3D(T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>, T, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
FieldVector3D(T, Vector3D, T, Vector3D, T, Vector3D, T, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
FieldVector3D(double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>, double, FieldVector3D<T>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
FIFTIES_EPOCH - Static variable in class org.orekit.time.DateComponents
Reference epoch for 1950 dates: 1950-01-01.
FIFTIES_EPOCH_TAI - Static variable in class org.orekit.time.AbsoluteDate
Reference epoch for 1950 dates: 1950-01-01T00:00:00 TAI.
FIFTIES_EPOCH_TT - Static variable in class org.orekit.time.AbsoluteDate
Reference epoch for 1950 dates: 1950-01-01T00:00:00 Terrestrial Time.
FIFTIES_EPOCH_UTC - Static variable in class org.orekit.time.AbsoluteDate
Reference epoch for 1950 dates: 1950-01-01T00:00:00 UTC.
fill(double[]) - Method in class org.apache.commons.math3.random.ValueServer
Fills the input array with values generated using getNext() repeatedly.
fill(int) - Method in class org.apache.commons.math3.random.ValueServer
Returns an array of length length with values generated using getNext() repeatedly.
fillHalfRow(double, Vector3D, double[], int) - Static method in class org.orekit.orbits.Orbit
Fill a Jacobian half row with a single vector.
fillHalfRow(double, Vector3D, double, Vector3D, double[], int) - Static method in class org.orekit.orbits.Orbit
Fill a Jacobian half row with a linear combination of vectors.
fillHalfRow(double, Vector3D, double, Vector3D, double, Vector3D, double[], int) - Static method in class org.orekit.orbits.Orbit
Fill a Jacobian half row with a linear combination of vectors.
fillHalfRow(double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D, double[], int) - Static method in class org.orekit.orbits.Orbit
Fill a Jacobian half row with a linear combination of vectors.
fillHalfRow(double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D, double[], int) - Static method in class org.orekit.orbits.Orbit
Fill a Jacobian half row with a linear combination of vectors.
fillHalfRow(double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D, double[], int) - Static method in class org.orekit.orbits.Orbit
Fill a Jacobian half row with a linear combination of vectors.
fillHistory(EOP1980History) - Method in class org.orekit.frames.configuration.eop.BulletinBFilesLoader
Load celestial body.
fillHistory(EOP2000History) - Method in class org.orekit.frames.configuration.eop.BulletinBFilesLoader
Load celestial body.
fillHistory(EOP1980History) - Method in class org.orekit.frames.configuration.eop.EOP05C04FilesLoader
Load celestial body.
fillHistory(EOP2000History) - Method in class org.orekit.frames.configuration.eop.EOP05C04FilesLoader
Load celestial body.
fillHistory(EOP1980History, InputStream) - Static method in class org.orekit.frames.configuration.eop.EOP05C04FilesLoader
Fills the history object directy with data from the InputStream, bypassing the Orekit data loaders.
fillHistory(EOP2000History, InputStream) - Static method in class org.orekit.frames.configuration.eop.EOP05C04FilesLoader
Fills the history object directy with data from the InputStream, bypassing the Orekit data loaders.
fillHistory(EOP1980History) - Method in class org.orekit.frames.configuration.eop.EOP08C04FilesLoader
Load celestial body.
fillHistory(EOP2000History) - Method in class org.orekit.frames.configuration.eop.EOP08C04FilesLoader
Load celestial body.
fillHistory(EOP1980History, InputStream) - Static method in class org.orekit.frames.configuration.eop.EOP08C04FilesLoader
Fills the history object directy with data from the InputStream, bypassing the Orekit data loaders.
fillHistory(EOP2000History, InputStream) - Static method in class org.orekit.frames.configuration.eop.EOP08C04FilesLoader
Fills the history object directy with data from the InputStream, bypassing the Orekit data loaders.
fillHistory(Collection<EOP1980Entry>, EOP1980History) - Static method in class org.orekit.frames.configuration.eop.EOP1980History
Populates a EOP1980History instance from a collection of EOP1980Entry.
fillHistory(EOP1980History) - Method in interface org.orekit.frames.configuration.eop.EOP1980HistoryLoader
Load celestial body.
fillHistory(Collection<EOP2000Entry>, EOP2000History) - Static method in class org.orekit.frames.configuration.eop.EOP2000History
Populates a EOP2000History instance from a collection of EOP2000Entry.
fillHistory(EOP2000History) - Method in interface org.orekit.frames.configuration.eop.EOP2000HistoryLoader
Load celestial body.
fillHistory(EOP1980History) - Method in class org.orekit.frames.configuration.eop.NoEOP1980HistoryLoader
History with zero orientation.
fillHistory(EOP1980History) - Method in class org.orekit.frames.configuration.eop.RapidDataAndPredictionColumnsLoader
Load celestial body.
fillHistory(EOP2000History) - Method in class org.orekit.frames.configuration.eop.RapidDataAndPredictionColumnsLoader
Load celestial body.
fillHistory(EOP1980History) - Method in class org.orekit.frames.configuration.eop.RapidDataAndPredictionXMLLoader
Load celestial body.
fillHistory(EOP2000History) - Method in class org.orekit.frames.configuration.eop.RapidDataAndPredictionXMLLoader
Load celestial body.
filterStep(double, boolean, boolean) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Filter the integration step.
finalizeStep() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Finalize the step.
findSameChromosome(Population) - Method in class org.apache.commons.math3.genetics.Chromosome
Searches the population for another chromosome with the same representation.
FINITE - Static variable in class org.apache.commons.math3.dfp.Dfp
Indicator value for normal finite numbers.
FiniteDifferencesDifferentiator - Class in org.apache.commons.math3.analysis.differentiation
Univariate functions differentiator using finite differences.
FiniteDifferencesDifferentiator(int, double) - Constructor for class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Build a differentiator with number of points and step size when independent variable is unbounded.
FiniteDifferencesDifferentiator(int, double, double, double) - Constructor for class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Build a differentiator with number of points and step size when independent variable is bounded.
fireInitializationEvent(IterationEvent) - Method in class org.apache.commons.math3.util.IterationManager
Informs all registered listeners that the initial phase (prior to the main iteration loop) has been completed.
fireIterationPerformedEvent(IterationEvent) - Method in class org.apache.commons.math3.util.IterationManager
Informs all registered listeners that a new iteration (in the main iteration loop) has been performed.
fireIterationStartedEvent(IterationEvent) - Method in class org.apache.commons.math3.util.IterationManager
Informs all registered listeners that a new iteration (in the main iteration loop) has been started.
fireTerminationEvent(IterationEvent) - Method in class org.apache.commons.math3.util.IterationManager
Informs all registered listeners that the final phase (post-iterations) has been completed.
firstIncluded() - Method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
Returns a value indicating whether the first point should be passed to the underlying fixed step size step handler.
firstIntersection(Vector3D, Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Get the first sub-hyperplane crossed by a semi-infinite line.
FirstOrderConverter - Class in org.apache.commons.math3.ode
This class converts second order differential equations to first order ones.
FirstOrderConverter(SecondOrderDifferentialEquations) - Constructor for class org.apache.commons.math3.ode.FirstOrderConverter
Simple constructor.
FirstOrderDifferentialEquations - Interface in org.apache.commons.math3.ode
This interface represents a first order differential equations set.
FirstOrderIntegrator - Interface in org.apache.commons.math3.ode
This interface represents a first order integrator for differential equations.
fit(T, double[]) - Method in class org.apache.commons.math3.fitting.CurveFitter
Fit a curve.
fit(int, T, double[]) - Method in class org.apache.commons.math3.fitting.CurveFitter
Fit a curve.
fit(double[]) - Method in class org.apache.commons.math3.fitting.GaussianFitter
Fits a Gaussian function to the observed points.
fit() - Method in class org.apache.commons.math3.fitting.GaussianFitter
Fits a Gaussian function to the observed points.
fit(double[]) - Method in class org.apache.commons.math3.fitting.HarmonicFitter
Fit an harmonic function to the observed points.
fit() - Method in class org.apache.commons.math3.fitting.HarmonicFitter
Fit an harmonic function to the observed points.
fit(int, double[]) - Method in class org.apache.commons.math3.fitting.PolynomialFitter
Get the coefficients of the polynomial fitting the weighted data points.
fit(double[]) - Method in class org.apache.commons.math3.fitting.PolynomialFitter
Get the coefficients of the polynomial fitting the weighted data points.
fit(T, double[]) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated. Fit a curve.
fit(int, T, double[]) - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated. Fit a curve.
fit(double[]) - Method in class org.apache.commons.math3.optimization.fitting.GaussianFitter
Deprecated. Fits a Gaussian function to the observed points.
fit() - Method in class org.apache.commons.math3.optimization.fitting.GaussianFitter
Deprecated. Fits a Gaussian function to the observed points.
fit(double[]) - Method in class org.apache.commons.math3.optimization.fitting.HarmonicFitter
Deprecated. Fit an harmonic function to the observed points.
fit() - Method in class org.apache.commons.math3.optimization.fitting.HarmonicFitter
Deprecated. Fit an harmonic function to the observed points.
fit() - Method in class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated. Since 3.1 (to be removed in 4.0). Please use PolynomialFitter.fit(double[]) instead.
fit(int, double[]) - Method in class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated. Get the coefficients of the polynomial fitting the weighted data points.
fit(double[]) - Method in class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated. Get the coefficients of the polynomial fitting the weighted data points.
fit(double[]) - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Find the TLE elements that minimize the mean square error for a sample of states.
fit(double[]) - Method in class org.orekit.propagation.analytical.tle.DifferentialOrbitConverter
Find the TLE elements that minimize the mean square error for a sample of states.
fit(double[]) - Method in class org.orekit.propagation.analytical.tle.LevenbergMarquardtOrbitConverter
Find the TLE elements that minimize the mean square error for a sample of states.
fit() - Method in class org.orekit.utils.SecularAndHarmonic
Fit parameters.
Fitness - Interface in org.apache.commons.math3.genetics
Fitness of a chromosome.
fitness() - Method in interface org.apache.commons.math3.genetics.Fitness
Compute the fitness.
fix1stArgument(BivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Creates a unary function by fixing the first argument of a binary function.
fix2ndArgument(BivariateFunction, double) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Creates a unary function by fixing the second argument of a binary function.
FixedDelayModel - Class in org.orekit.models.earth
A static tropospheric model that interpolates the actual tropospheric delay based on values read from a configuration file (tropospheric-delay.txt) via the DataProvidersManager.
FixedDelayModel(double[], double[], double[][], double) - Constructor for class org.orekit.models.earth.FixedDelayModel
Creates a new FixedDelayModel instance.
FixedDelayModel(String, double) - Constructor for class org.orekit.models.earth.FixedDelayModel
Creates a new FixedDelayModel instance, and loads the delay values from the given resource via the DataProvidersManager.
FixedElapsedTime - Class in org.apache.commons.math3.genetics
Stops after a fixed amount of time has elapsed.
FixedElapsedTime(long) - Constructor for class org.apache.commons.math3.genetics.FixedElapsedTime
Create a new FixedElapsedTime instance.
FixedElapsedTime(long, TimeUnit) - Constructor for class org.apache.commons.math3.genetics.FixedElapsedTime
Create a new FixedElapsedTime instance.
FixedGenerationCount - Class in org.apache.commons.math3.genetics
Stops after a fixed number of generations.
FixedGenerationCount(int) - Constructor for class org.apache.commons.math3.genetics.FixedGenerationCount
Create a new FixedGenerationCount instance.
FixedRate - Class in org.orekit.attitudes
This class handles a simple attitude provider at constant rate around a fixed axis.
FixedRate(Attitude) - Constructor for class org.orekit.attitudes.FixedRate
Creates a new instance.
FixedStepAttitudeEphemerisGenerator - Class in org.orekit.attitudes
This class handles the generation of attitude ephemeris from an attitude laws sequence AttitudeLegsSequence, using a fixed time step.
The ephemeris generation can be done setting the generation time interval (the default value is the time interval of the sequence), and the treatment to apply to the transition points of the sequence (ignore them, compute the attitude of the initial date of the laws, compute the attitude of the initial and final date of the laws).
FixedStepAttitudeEphemerisGenerator(AttitudeLegsSequence, double) - Constructor for class org.orekit.attitudes.FixedStepAttitudeEphemerisGenerator
Builds an attitude ephemeris generator using a fixed time step and ignoring the attitude law transition points of the sequence.
FixedStepAttitudeEphemerisGenerator(AttitudeLegsSequence, double, int) - Constructor for class org.orekit.attitudes.FixedStepAttitudeEphemerisGenerator
Builds an attitude ephemeris generator using a fixed time step and choosing the treatment to apply to the transition points of the sequence.
FixedStepHandler - Interface in org.apache.commons.math3.ode.sampling
This interface represents a handler that should be called after each successful fixed step.
FixedTransformProvider - Class in org.orekit.frames.transformations
Transform provider using fixed transform.
FixedTransformProvider(Transform) - Constructor for class org.orekit.frames.transformations.FixedTransformProvider
Simple constructor.
FLAG_DIV_ZERO - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for division by zero.
FLAG_INEXACT - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for inexact result.
FLAG_INVALID - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for invalid operation.
FLAG_OVERFLOW - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for overflow.
FLAG_UNDERFLOW - Static variable in class org.apache.commons.math3.dfp.DfpField
IEEE 854-1987 flag for underflow.
Flags - Class in org.orekit.forces.atmospheres.MSIS2000
Class Flags Switches: to turn on and off particular variations use these switches.
Flags() - Constructor for class org.orekit.forces.atmospheres.MSIS2000.Flags
Constructor.
flatten(Object[]) - Static method in class org.apache.commons.math3.exception.util.ArgUtils
Transform a multidimensional array into a one-dimensional list.
fLaw - Variable in class org.orekit.attitudes.AbstractSlew
The attitude law after the slew.
floatValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a float.
floatValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction as a float.
floatValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a float.
floor() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the largest whole number smaller than instance.
Floor - Class in org.apache.commons.math3.analysis.function
floor function.
Floor() - Constructor for class org.apache.commons.math3.analysis.function.Floor
 
floor() - Method in class org.apache.commons.math3.dfp.Dfp
Round to an integer using the round floor mode.
floor() - Method in interface org.apache.commons.math3.RealFieldElement
Get the largest whole number smaller than instance.
floor(double) - Static method in class org.apache.commons.math3.util.FastMath
Get the largest whole number smaller than x.
FLOW_RATE - Static variable in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Parameter name for flow rate.
ForceModel - Interface in org.orekit.forces
This interface represents a force modifying spacecraft motion.
forceOnFacet(SpacecraftState, IPart, double, Vector3D) - Static method in class fr.cnes.sirius.patrius.assembly.models.AeroModel
Method to compute the force for a plane model.
forceOnFacet(SpacecraftState, IPart, Vector3D) - Static method in class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
Method to compute the force for a plane model.
forceOnSphere(SpacecraftState, IPart, double, Vector3D) - Static method in class fr.cnes.sirius.patrius.assembly.models.AeroModel
Method to compute the force for a sphere model.
forceOnSphere(IPart, Vector3D) - Static method in class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
Method to compute the force for a spherical model.
forceSide(int, UnivariateFunction, BracketedUnivariateSolver<UnivariateFunction>, double, double, double, AllowedSolution) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Force a root found by a non-bracketing solver to lie on a specified side, as if the solver was a bracketing one.
ForcesStepHandler - Class in fr.cnes.sirius.patrius.stela.propagation
Step handler handling forces requiring to be updated every step and not every substep.
ForcesStepHandler(OrbitNatureConverter, NonInertialContribution) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.ForcesStepHandler
Constructor.
format(Complex) - Method in class org.apache.commons.math3.complex.ComplexFormat
This method calls ComplexFormat.format(Object,StringBuffer,FieldPosition).
format(Double) - Method in class org.apache.commons.math3.complex.ComplexFormat
This method calls ComplexFormat.format(Object,StringBuffer,FieldPosition).
format(Complex, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.complex.ComplexFormat
Formats a Complex object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.complex.ComplexFormat
Formats a object to produce a string.
format(double, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.AbstractFormat
Formats a double value as a fraction and appends the result to a StringBuffer.
format(long, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.AbstractFormat
Formats a long value as a fraction and appends the result to a StringBuffer.
format(BigFraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
Formats a BigFraction object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
Formats an object and appends the result to a StringBuffer.
format(Fraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.FractionFormat
Formats a Fraction object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.FractionFormat
Formats an object and appends the result to a StringBuffer.
format(BigFraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
Formats a BigFraction object to produce a string.
format(Fraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
Formats a Fraction object to produce a string.
format(Vector<Euclidean1D>, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Formats a Vector object to produce a string.
format(Vector<Euclidean3D>, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Formats a Vector3D object to produce a string.
format(Vector<Euclidean2D>, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Formats a Vector object to produce a string.
format(Vector<S>) - Method in class org.apache.commons.math3.geometry.VectorFormat
Formats a Vector object to produce a string.
format(Vector<S>, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.geometry.VectorFormat
Formats a Vector object to produce a string.
format(StringBuffer, FieldPosition, double...) - Method in class org.apache.commons.math3.geometry.VectorFormat
Formats the coordinates of a Vector to produce a string.
format(RealMatrix) - Method in class org.apache.commons.math3.linear.RealMatrixFormat
This method calls RealMatrixFormat.format(RealMatrix,StringBuffer,FieldPosition).
format(RealMatrix, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Formats a RealMatrix object to produce a string.
format(RealVector) - Method in class org.apache.commons.math3.linear.RealVectorFormat
This method calls RealVectorFormat.format(RealVector,StringBuffer,FieldPosition).
format(RealVector, StringBuffer, FieldPosition) - Method in class org.apache.commons.math3.linear.RealVectorFormat
Formats a RealVector object to produce a string.
formatBigFraction(BigFraction) - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
This static method calls formatBigFraction() on a default instance of BigFractionFormat.
formatDouble(double, NumberFormat, StringBuffer, FieldPosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Formats a double value to produce a string.
formatFraction(Fraction) - Static method in class org.apache.commons.math3.fraction.FractionFormat
This static method calls formatFraction() on a default instance of FractionFormat.
FOUR_FIFTHS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "4/5".
FOUR_FIFTHS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "4/5".
FOUR_POINT_FIVE - Static variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Constant 4.5
FourierDecompositionEngine - Class in org.apache.commons.math3.analysis.polynomials
Decompose a UnivariateFunction as a Fourier Series using TrigonometricPolynomialFunction representation.
FourierDecompositionEngine(UnivariateIntegrator) - Constructor for class org.apache.commons.math3.analysis.polynomials.FourierDecompositionEngine
Constructor.
FourierSeries - Class in org.apache.commons.math3.analysis.polynomials
This class represents a finite Fourier Series
FourierSeries(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.FourierSeries
Constructor for the FourierSeries.
FourierSeriesApproximation - Class in org.apache.commons.math3.analysis.polynomials
Holder for a UnivariateFunction and its FourierSeries approximation
FourierSeriesApproximation(UnivariateFunction, FourierSeries) - Constructor for class org.apache.commons.math3.analysis.polynomials.FourierSeriesApproximation
Constructor.
fr.cnes.sirius.patrius - package fr.cnes.sirius.patrius
 
fr.cnes.sirius.patrius.assembly - package fr.cnes.sirius.patrius.assembly
 
fr.cnes.sirius.patrius.assembly.models - package fr.cnes.sirius.patrius.assembly.models
 
fr.cnes.sirius.patrius.assembly.properties - package fr.cnes.sirius.patrius.assembly.properties
 
fr.cnes.sirius.patrius.assembly.properties.features - package fr.cnes.sirius.patrius.assembly.properties.features
 
fr.cnes.sirius.patrius.bodies - package fr.cnes.sirius.patrius.bodies
 
fr.cnes.sirius.patrius.events - package fr.cnes.sirius.patrius.events
 
fr.cnes.sirius.patrius.events.multi - package fr.cnes.sirius.patrius.events.multi
 
fr.cnes.sirius.patrius.events.postprocessing - package fr.cnes.sirius.patrius.events.postprocessing
 
fr.cnes.sirius.patrius.events.sensor - package fr.cnes.sirius.patrius.events.sensor
 
fr.cnes.sirius.patrius.exception.util - package fr.cnes.sirius.patrius.exception.util
 
fr.cnes.sirius.patrius.fieldsofview - package fr.cnes.sirius.patrius.fieldsofview
 
fr.cnes.sirius.patrius.forces - package fr.cnes.sirius.patrius.forces
 
fr.cnes.sirius.patrius.forces.maneuvers - package fr.cnes.sirius.patrius.forces.maneuvers
 
fr.cnes.sirius.patrius.forces.radiation - package fr.cnes.sirius.patrius.forces.radiation
 
fr.cnes.sirius.patrius.groundstation - package fr.cnes.sirius.patrius.groundstation
 
fr.cnes.sirius.patrius.guidance - package fr.cnes.sirius.patrius.guidance
 
fr.cnes.sirius.patrius.projections - package fr.cnes.sirius.patrius.projections
 
fr.cnes.sirius.patrius.propagation - package fr.cnes.sirius.patrius.propagation
 
fr.cnes.sirius.patrius.propagation.events.multi - package fr.cnes.sirius.patrius.propagation.events.multi
 
fr.cnes.sirius.patrius.propagation.numerical.multi - package fr.cnes.sirius.patrius.propagation.numerical.multi
 
fr.cnes.sirius.patrius.propagation.precomputed.multi - package fr.cnes.sirius.patrius.propagation.precomputed.multi
 
fr.cnes.sirius.patrius.propagation.sampling.multi - package fr.cnes.sirius.patrius.propagation.sampling.multi
 
fr.cnes.sirius.patrius.signalpropagation - package fr.cnes.sirius.patrius.signalpropagation
 
fr.cnes.sirius.patrius.signalpropagation.iono - package fr.cnes.sirius.patrius.signalpropagation.iono
 
fr.cnes.sirius.patrius.stela - package fr.cnes.sirius.patrius.stela
 
fr.cnes.sirius.patrius.stela.bodies - package fr.cnes.sirius.patrius.stela.bodies
 
fr.cnes.sirius.patrius.stela.forces - package fr.cnes.sirius.patrius.stela.forces
 
fr.cnes.sirius.patrius.stela.forces.atmospheres - package fr.cnes.sirius.patrius.stela.forces.atmospheres
 
fr.cnes.sirius.patrius.stela.forces.drag - package fr.cnes.sirius.patrius.stela.forces.drag
 
fr.cnes.sirius.patrius.stela.forces.gravity - package fr.cnes.sirius.patrius.stela.forces.gravity
 
fr.cnes.sirius.patrius.stela.forces.noninertial - package fr.cnes.sirius.patrius.stela.forces.noninertial
 
fr.cnes.sirius.patrius.stela.forces.radiation - package fr.cnes.sirius.patrius.stela.forces.radiation
 
fr.cnes.sirius.patrius.stela.orbits - package fr.cnes.sirius.patrius.stela.orbits
 
fr.cnes.sirius.patrius.stela.propagation - package fr.cnes.sirius.patrius.stela.propagation
 
fr.cnes.sirius.patrius.stela.propagation.data - package fr.cnes.sirius.patrius.stela.propagation.data
 
fr.cnes.sirius.patrius.tools.ephemerisComparator - package fr.cnes.sirius.patrius.tools.ephemerisComparator
 
fr.cnes.sirius.patrius.tools.exception - package fr.cnes.sirius.patrius.tools.exception
 
fr.cnes.sirius.patrius.tools.exception.util - package fr.cnes.sirius.patrius.tools.exception.util
 
fr.cnes.sirius.patrius.tools.force.validation - package fr.cnes.sirius.patrius.tools.force.validation
 
fr.cnes.sirius.patrius.utils - package fr.cnes.sirius.patrius.utils
 
fr.cnes.sirius.patrius.wrenches - package fr.cnes.sirius.patrius.wrenches
 
fr.cnes.sirius.validate.duration - package fr.cnes.sirius.validate.duration
 
fr.cnes.sirius.validate.files - package fr.cnes.sirius.validate.files
 
fr.cnes.sirius.validate.jqnum - package fr.cnes.sirius.validate.jqnum
 
fr.cnes.sirius.validate.mocks.ephemeris - package fr.cnes.sirius.validate.mocks.ephemeris
 
fr.cnes.sirius.validate.parallel - package fr.cnes.sirius.validate.parallel
 
fr.cnes.sirius.validate.validationTool - package fr.cnes.sirius.validate.validationTool
 
Fraction - Class in org.apache.commons.math3.fraction
Representation of a rational number.
Fraction(double) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction given the double value.
Fraction(double, double, int) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction given the double value and maximum error allowed.
Fraction(double, int) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction given the double value and maximum denominator.
Fraction(int) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction from an int.
Fraction(int, int) - Constructor for class org.apache.commons.math3.fraction.Fraction
Create a fraction given the numerator and denominator.
FractionConversionException - Exception in org.apache.commons.math3.fraction
Error thrown when a double value cannot be converted to a fraction in the allowed number of iterations.
FractionConversionException(double, int) - Constructor for exception org.apache.commons.math3.fraction.FractionConversionException
Constructs an exception with specified formatted detail message.
FractionConversionException(double, long, long) - Constructor for exception org.apache.commons.math3.fraction.FractionConversionException
Constructs an exception with specified formatted detail message.
FractionField - Class in org.apache.commons.math3.fraction
Representation of the fractional numbers field.
FractionFormat - Class in org.apache.commons.math3.fraction
Formats a Fraction number in proper format or improper format.
FractionFormat() - Constructor for class org.apache.commons.math3.fraction.FractionFormat
Create an improper formatting instance with the default number format for the numerator and denominator.
FractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.FractionFormat
Create an improper formatting instance with a custom number format for both the numerator and denominator.
FractionFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.FractionFormat
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
fractionMatrixToRealMatrix(FieldMatrix<Fraction>) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Convert a FieldMatrix/Fraction matrix to a RealMatrix.
FRAME - Static variable in class fr.cnes.sirius.patrius.assembly.Assembly
String Frame
Frame - Class in org.orekit.frames
Tridimensional references frames class.
Frame(String, boolean) - Constructor for class org.orekit.frames.Frame
Private constructor used only for the root frame.
Frame(Frame, Transform, String) - Constructor for class org.orekit.frames.Frame
Build a non-inertial frame from its transform with respect to its parent.
Frame(Frame, TransformProvider, String) - Constructor for class org.orekit.frames.Frame
Build a non-inertial frame from its transform with respect to its parent.
Frame(Frame, Transform, String, boolean) - Constructor for class org.orekit.frames.Frame
Build a frame from its transform with respect to its parent.
Frame(Frame, TransformProvider, String, boolean) - Constructor for class org.orekit.frames.Frame
Build a frame from its transform with respect to its parent.
frame - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
Reference frame.
FrameAncestorException - Exception in org.orekit.errors
This class is the base class for exception thrown by the UpdatableFrame.updateTransform(Frame, Frame, Transform, AbsoluteDate) method.
FrameAncestorException(Localizable, Object...) - Constructor for exception org.orekit.errors.FrameAncestorException
Simple constructor.
FramesConfiguration - Interface in org.orekit.frames.configuration
Interface providing the basic services for frame configurations.
FramesConfigurationBuilder - Class in org.orekit.frames.configuration
Frame configuration builder utility, to assist the user in creating a FramesConfiguration.
FramesConfigurationBuilder() - Constructor for class org.orekit.frames.configuration.FramesConfigurationBuilder
Public default constructor.
FramesConfigurationBuilder(FramesConfiguration) - Constructor for class org.orekit.frames.configuration.FramesConfigurationBuilder
Public constructor.
FramesConfigurationFactory - Class in org.orekit.frames.configuration
Frames configuration factory.
FramesConfigurationImplementation - Class in org.orekit.frames.configuration
This class represents a frames configuration.
FramesConfigurationImplementation() - Constructor for class org.orekit.frames.configuration.FramesConfigurationImplementation
Protected constructor.
FramesFactory - Class in org.orekit.frames
Factory for predefined reference frames.
FREE - Static variable in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Status indicator for free table entries.
FREE - Static variable in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Status indicator for free table entries.
freeze() - Method in class org.orekit.frames.transformations.Transform
Get a freezed transform.
Frequency - Class in org.apache.commons.math3.stat
Maintains a frequency distribution.
Frequency() - Constructor for class org.apache.commons.math3.stat.Frequency
Default constructor.
Frequency(Comparator<?>) - Constructor for class org.apache.commons.math3.stat.Frequency
Constructor allowing values Comparator to be specified.
fst(double[]) - Method in class org.apache.commons.math3.transform.FastSineTransformer
Perform the FST algorithm (including inverse).
FULL - Static variable in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Status indicator for full table entries.
FULL - Static variable in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Status indicator for full table entries.
FunctionUtils - Class in org.apache.commons.math3.analysis
Utilities for manipulating function objects.
FUTURE_INFINITY - Static variable in class org.orekit.time.AbsoluteDate
Dummy date at infinity in the future direction.

G

g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.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.CombinedPhenomenaDetector
Compute the value of the switching function for a combination (AND or OR) of two phenomena.
After computing the switching function of each detector and, if necessary, changing its sign to apply a general convention (g>0 if the phenomenon associated to an event is active), it returns one between the two g functions, according to the boolean operator.
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.EarthZoneDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
The switching function is specific case of the extrema three bodies angle detector.
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.RFVisibilityDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
 
g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
 
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.SensorInhibitionDetector
 
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
 
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.StationToSatMutualVisibilityDetector
 
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
 
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
Compute the value of the switching function.
g(double, double[]) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMonoEventDetector
 
g(double, double[]) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMultiEventDetector
 
g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
 
g(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.OneSatEventDetectorWrapper
 
g(SpacecraftState) - Method in class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Compute the value of the switching function.
g(double, double[]) - Method in interface org.apache.commons.math3.ode.events.EventHandler
Compute the value of the switching function.
g(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.GTest
Computes the G statistic for Goodness of Fit comparing observed and expected frequency counts.
g(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
g(SpacecraftState) - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.AbstractDetector
Compute the value of the switching function.
g(double, double[]) - Method in class org.orekit.propagation.events.AdaptedEventDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.AlignmentDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.AltitudeDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.AnomalyDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.AOLDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.ApparentElevationDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.ApsideDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.BetaAngleDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.CircularFieldOfViewDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.DateDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.DihedralFieldOfViewDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.DistanceDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.EclipseDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.ElevationDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in interface org.orekit.propagation.events.EventDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.EventShifter
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.ExtremaDistanceDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.ExtremaElevationDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.ExtremaLatitudeDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.ExtremaLongitudeDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
 
g(Map<String, SpacecraftState>) - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.GroundMaskElevationDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.LatitudeDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.LocalTimeDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.LongitudeDetector
 
g(Map<String, SpacecraftState>) - Method in interface org.orekit.propagation.events.multi.MultiEventDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.NadirSolarIncidenceDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.NodeDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.NullMassDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.NullMassPartDetector
Compute the value of the switching function.
g(SpacecraftState) - Method in class org.orekit.propagation.events.SolarTimeDetector
 
g(SpacecraftState) - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
Compute the value of the switching function.
g(Map<String, SpacecraftState>) - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
 
G0_STANDARD_GRAVITY - Static variable in interface org.orekit.utils.Constants
Standard gravity constant, used in maneuvers definition: 9.80665 m/s2.
GALILEO_EPOCH - Static variable in class org.orekit.time.AbsoluteDate
Reference epoch for Galileo System Time: 1999-08-22T00:00:00 UTC.
GALILEO_EPOCH - Static variable in class org.orekit.time.DateComponents
Reference epoch for Galileo System Time: 1999-08-22.
GalileoAlmanacParameters - Class in fr.cnes.sirius.patrius.utils
This class is a simple container for galileo almanac parameters.
GalileoAlmanacParameters(double, int, double, double, double, double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.utils.GalileoAlmanacParameters
Creates an instance of Galileo Almanac parameters
GalileoScale - Class in org.orekit.time
Galileo system time scale.
Gamma - Class in org.apache.commons.math3.special
This is a utility class that provides computation methods related to the Γ (Gamma) family of functions.
GAMMA - Static variable in class org.apache.commons.math3.special.Gamma
Euler-Mascheroni constant
gamma(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the value of Γ(x).
GammaDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Gamma distribution.
GammaDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.GammaDistribution
Creates a new gamma distribution with specified values of the shape and scale parameters.
GammaDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.GammaDistribution
Creates a new gamma distribution with specified values of the shape and scale parameters.
GammaDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.GammaDistribution
Creates a Gamma distribution.
Gaussian - Class in org.apache.commons.math3.analysis.function
Gaussian function.
Gaussian(double, double, double) - Constructor for class org.apache.commons.math3.analysis.function.Gaussian
Gaussian with given normalization factor, mean and standard deviation.
Gaussian(double, double) - Constructor for class org.apache.commons.math3.analysis.function.Gaussian
Normalized gaussian with given mean and standard deviation.
Gaussian() - Constructor for class org.apache.commons.math3.analysis.function.Gaussian
Normalized gaussian with zero mean and unit standard deviation.
Gaussian.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the Gaussian, ordered as follows: Norm Mean Standard deviation
Gaussian.Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Gaussian.Parametric
 
GAUSSIAN_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Gaussian random deviates with mean = μ, std dev = σ.
GaussianFitter - Class in org.apache.commons.math3.fitting
Fits points to a Gaussian function.
GaussianFitter(MultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.fitting.GaussianFitter
Constructs an instance using the specified optimizer.
GaussianFitter - Class in org.apache.commons.math3.optimization.fitting
Deprecated. As of 3.1 (to be removed in 4.0).
GaussianFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.GaussianFitter
Deprecated. Constructs an instance using the specified optimizer.
GaussianFitter.ParameterGuesser - Class in org.apache.commons.math3.fitting
Guesses the parameters norm, mean, and sigma of a Gaussian.Parametric based on the specified observed points.
GaussianFitter.ParameterGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math3.fitting.GaussianFitter.ParameterGuesser
Constructs instance with the specified observed points.
GaussianFitter.ParameterGuesser - Class in org.apache.commons.math3.optimization.fitting
Deprecated. Guesses the parameters norm, mean, and sigma of a Gaussian.Parametric based on the specified observed points.
GaussianFitter.ParameterGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math3.optimization.fitting.GaussianFitter.ParameterGuesser
Deprecated. Constructs instance with the specified observed points.
GaussianRandomGenerator - Class in org.apache.commons.math3.random
This class is a gaussian normalized random generator for scalars.
GaussianRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math3.random.GaussianRandomGenerator
Create a new generator.
GaussIntegrator - Class in org.apache.commons.math3.analysis.integration.gauss
Class that implements the Gaussian rule for integrating a weighted function.
GaussIntegrator(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.integration.gauss.GaussIntegrator
Creates an integrator from the given points and weights.
GaussIntegrator(Pair<double[], double[]>) - Constructor for class org.apache.commons.math3.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 org.apache.commons.math3.analysis.integration.gauss
Class that provides different ways to compute the nodes and weights to be used by the Gaussian integration rule.
GaussIntegratorFactory() - Constructor for class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
 
GaussNewtonOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector.jacobian
Gauss-Newton least-squares solver.
GaussNewtonOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.GaussNewtonOptimizer
Simple constructor with default settings.
GaussNewtonOptimizer(boolean, ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.GaussNewtonOptimizer
 
GaussNewtonOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated. As of 3.1 (to be removed in 4.0).
GaussNewtonOptimizer() - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
Deprecated. See SimpleVectorValueChecker.SimpleVectorValueChecker()
GaussNewtonOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
Deprecated. Simple constructor with default settings.
GaussNewtonOptimizer(boolean) - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
Deprecated. See SimpleVectorValueChecker.SimpleVectorValueChecker()
GaussNewtonOptimizer(boolean, ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.GaussNewtonOptimizer
Deprecated.  
gcd(int, int) - Static method in class org.apache.commons.math3.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 org.apache.commons.math3.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.
gDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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.
GeneralizedFlamsteedSamson(GeodeticPoint, ProjectionEllipsoid, double) - Constructor for class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
Constructor : Mercator constructor is used with : a pivot point a reference shape 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 org.orekit.frames.configuration.precessionnutation.CIPCoordinatesGenerator
Generate a chronologically sorted list of entries to be cached.
generate(TidalCorrection, AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.TidalCorrectionGenerator
Generate a chronologically sorted list of entries to be cached.
generate(T, AbsoluteDate) - Method in interface org.orekit.utils.TimeStampedGenerator
Generate a chronologically sorted list of entries to be cached.
generateEphemeris(Frame) - Method in class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
Computes attitude ephemeris using a fixed or variable time step.
generateEphemeris(AbsoluteDateInterval, Frame) - Method in class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
Computes attitude ephemeris using a fixed or variable time step and choosing the interval of validity.
generateSpacecraftState(PVCoordinatesProvider, AttitudeProvider, AttitudeProvider, double, AbsoluteDateInterval, Frame, double) - Static method in class org.orekit.propagation.precomputed.AbstractEphemeris
Creates a spacecraft array with constant step size.
GenericCodingEventDetector - Class in fr.cnes.sirius.patrius.events
This class represents an all-purpose implementation of the CodingEventDetector interface.
It works using the EventDetector provided in the constructor.
GenericCodingEventDetector(EventDetector, String, String, boolean, String) - Constructor for class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
Constructor for a GenericCodingEventDetector that supports a Phenomenon.
No delays and no occurrence numbers are associated to the events detected by this detector.
GenericCodingEventDetector(EventDetector, String, String, boolean, String, double, int) - Constructor for class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
Constructor for a GenericCodingEventDetector that supports a Phenomenon.
A delay and/or an occurrence number can be associated to the events detected by this detector.
When a delay is added to the detected events, two kinds of events will be coded:
- the original events, with their original codes;
- the delayed events, whose codes will be "DELAYED_" followed by the original code.
GenericCodingEventDetector(EventDetector, String, String) - Constructor for class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
Constructor for a GenericCodingEventDetector that does not support a Phenomenon.
GenericCodingEventDetector(EventDetector, String, String, double, int) - Constructor for class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
Constructor for a GenericCodingEventDetector that does not support a Phenomenon.
When a delay is added to the detected events, two kinds of events will be coded:
- the original events, with their original codes;
- the delayed events, whose codes will be "DELAYED_" followed by the original code.
GenericInterval<T> - Class in fr.cnes.sirius.patrius.utils
- Generic class to describe an interval.
GenericInterval(IntervalEndpointType, T, T, IntervalEndpointType) - Constructor for class fr.cnes.sirius.patrius.utils.GenericInterval
Constructor
Constructor : the T type must be defined.
GenericInterval<T> - Class in org.orekit.utils
- Generic class to describe an interval.
GenericInterval(IntervalEndpointType, T, T, IntervalEndpointType) - Constructor for class org.orekit.utils.GenericInterval
Constructor.
The input parameters have to be not null.
Otherwise a MathIllegalArgumentException is thrown.
GenericTargetDirection - Class in org.orekit.attitudes.directions
Direction described by a target PVCoordinatesProvider.
GenericTargetDirection(PVCoordinatesProvider) - Constructor for class org.orekit.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 org.apache.commons.math3.genetics
Implementation of a genetic algorithm.
GeneticAlgorithm(CrossoverPolicy, double, MutationPolicy, double, SelectionPolicy) - Constructor for class org.apache.commons.math3.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.
GEODETIC_PRECISION - Static variable in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Local precision for geodetic problem computation (in meters).
GeodeticPoint - Class in org.orekit.bodies
Point location relative to a 2D body surface.
GeodeticPoint(double, double, double) - Constructor for class org.orekit.bodies.GeodeticPoint
Build a new instance.
GeodPosition - Class in fr.cnes.sirius.patrius.stela.bodies
Class representing the geodetic representation of a position.
It is used to compute the spacecraft geodetic latitude when computing the atmospheric drag acceleration.
GeodPosition(double, double) - Constructor for class fr.cnes.sirius.patrius.stela.bodies.GeodPosition
Constructor
GeoMagneticDataProvider - Interface in org.orekit.models.earth
Interface for geomagnetic data provider.
GeoMagneticElements - Class in org.orekit.models.earth
Contains the elements to represent a magnetic field at a single point.
GeoMagneticElements(Vector3D) - Constructor for class org.orekit.models.earth.GeoMagneticElements
Construct a new element with the given field vector.
GeoMagneticField - Class in org.orekit.models.earth
Used to calculate the geomagnetic field at a given geodetic point on earth.
GeoMagneticField(String, double, int, int, double, double) - Constructor for class org.orekit.models.earth.GeoMagneticField
Create a new geomagnetic field model with the given parameters.
GeoMagneticFieldFactory - Class in org.orekit.models.earth
Factory for different GeoMagneticField models.
GeoMagneticFieldFactory.FieldModel - Enum in org.orekit.models.earth
The currently supported geomagnetic field models.
GeoMagneticModelReader - Class in org.orekit.models.earth
Loads geomagnetic field models from a given input stream.
GeoMagneticModelReader(String) - Constructor for class org.orekit.models.earth.GeoMagneticModelReader
Simple constructor.
GeometricBodyShape - Interface in org.orekit.bodies
Extended interface for celestial bodies shapes : extends the OREKIT's BodyShape interface by adding geometric methods.
GeometricMean - Class in org.apache.commons.math3.stat.descriptive.moment
Returns the geometric mean of the available values.
GeometricMean() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance
GeometricMean(GeometricMean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Copy constructor, creates a new GeometricMean identical to the original
GeometricMean(SumOfLogs) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance using the given SumOfLogs instance
geometricMean(double[]) - Static method in class org.apache.commons.math3.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 org.apache.commons.math3.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.
It is used in reverse station visibility event detection.
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 org.apache.commons.math3.UtilsCommonsMath
Epsilon for the geometry aspects.
get(int) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Get the stored value associated with the given key
get(int) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Get the stored value associated with the given key
get24HoursKp(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.DTM2000InputParameters
Get the last 24H mean geomagnetic index.
get24HoursKp(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.DTM2000SolarData
Get the last 24H mean geomagnetic index.
get24HoursKp(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
The Kp index is derived from the Ap index.
getA() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Get the semi-major axis.
getA() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Get array of cosine coefficients
getA(int, double) - Method in class org.apache.commons.math3.util.ContinuedFraction
Access the n-th a coefficient of the continued fraction.
getA() - Method in class org.orekit.orbits.ApsisOrbit
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.CartesianOrbit
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.CircularOrbit
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.EquatorialOrbit
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.KeplerianOrbit
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.Orbit
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Get the semi-major axis.
getA() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Get the semi-major axis.
getA() - Method in class org.orekit.propagation.SpacecraftState
Get the semi-major axis.
getA0() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Get value of order zero coefficient
getA1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Get the axis of the first rotation.
getA2() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Get the axis of the second rotation.
getA3() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Get the axis of the second rotation.
getAbscissa(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get the abscissa of a point with respect to the line.
getAbscissaGrid() - Method in class org.orekit.utils.InterpolationTableLoader
Returns a copy of the abscissa grid for the interpolation function.
getAbsoluteAccuracy() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the actual absolute accuracy.
getAbsoluteAccuracy() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the actual absolute accuracy.
getAbsoluteAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the absolute accuracy of the solver.
getAbsoluteAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the absolute accuracy of the solver.
getAbsoluteAccuracy() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Get the absolute accuracy.
getAbsoluteComparisonData() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
 
getAbsoluteThreshold() - Method in class org.apache.commons.math3.optim.AbstractConvergenceChecker
 
getAbsoluteThreshold() - Method in class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated.  
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 = α.
getAcceleration() - Method in class org.orekit.frames.transformations.Transform
Get the second time derivative of the translation.
getAcceleration() - Method in class org.orekit.utils.PVCoordinates
Gets the acceleration.
getAccuracy() - Method in class org.orekit.files.general.SatelliteInformation
Returns the estimated accuracy of the orbit entries for this satellite (in m).
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 org.orekit.propagation.MassProvider
Get the mass equation related to the part.
getAdditionalEquation(String) - Method in class org.orekit.propagation.SimpleMassModel
Get the mass equation related to the part.
getAdditionalState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.SimpleAdditionalStateProvider
Get the additional state.
getAdditionalState(AbsoluteDate) - Method in interface org.orekit.propagation.AdditionalStateProvider
Get the additional state.
getAdditionalState(String) - Method in class org.orekit.propagation.SpacecraftState
Get one additional state.
getAdditionalStateDimension() - Method in class org.orekit.propagation.numerical.JacobiansMapper
Compute the length of the one-dimensional additional state array needed.
getAdditionalStates() - Method in class org.orekit.propagation.SpacecraftState
Get additional states.
getAdditionalStatesInfos() - Method in class org.orekit.propagation.SpacecraftState
Get the additional states informations map.
getAdditionalStatesMass() - Method in class org.orekit.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 org.apache.commons.math3.stat.regression.RegressionResults
Returns the adjusted R-squared statistic, defined by the formula
getAe() - Method in interface org.orekit.forces.gravity.potential.PotentialCoefficientsProvider
Get the value of the central body reference radius.
getAe() - Method in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Get the value of the central body reference radius.
getAe() - Method in interface org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
Get the value of the central body reference radius.
getAe() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Get the value of the central body reference radius.
getAe() - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
 
getAe() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Getter for equatorial radius.
getAe() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Getter for equatorial radius.
getAffineLocalExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Express a Vector3D in ellipsoid local basis.
getAffineLocalExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Express a Vector3D in spheroid local frame.
getAffineLocalExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
Express a Vector3D in spheroid local frame.
getAffineStandardExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Express a Vector3D in standard basis.
getAffineStandardExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Express a Vector3D in standard basis.
getAffineStandardExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
Express a Vector3D in standard basis.
getAgency() - Method in class org.orekit.files.sp3.SP3File
Returns the agency that prepared this SP3 file.
getAlbedoPressure() - Method in class org.orekit.forces.radiation.ElementaryFlux
get the albedo pressure (N/M²)
getAlignAngle() - Method in class org.orekit.propagation.events.AlignmentDetector
Get the alignment angle (rad).
getAlignmentAngle() - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
Get the alignment angle.
getAllDerivatives() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get all partial derivatives.
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 org.orekit.propagation.MassProvider
Get the list of the name of the parts.
getAllPartsNames() - Method in class org.orekit.propagation.SimpleMassModel
Get the list of the name of the parts.
getAlpha() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Access the first shape parameter, alpha.
getAlpha() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Deprecated. as of version 3.1, GammaDistribution.getShape() should be preferred. This method will be removed in version 4.0.
getAlpha() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the azimuth of the vector.
getAlpha() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the azimuth of the vector.
getAlpha(PositionAngle) - Method in class org.orekit.orbits.CircularOrbit
Get the latitude argument.
getAlpha(PositionAngle) - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Get the latitude argument.
getAlphaE() - Method in class org.orekit.orbits.CircularOrbit
Get the eccentric latitude argument.
getAlphaE() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Get the eccentric latitude argument.
getAlphaM() - Method in class org.orekit.orbits.CircularOrbit
Get the mean latitude argument.
getAlphaM() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Get the mean latitude argument.
getAlphaV() - Method in class org.orekit.orbits.CircularOrbit
Get the true latitude argument.
getAlphaV() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Get the true latitude argument.
getAlt() - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Getter for alt.
getAltitude() - Method in class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Get the threshold altitude value.
getAltitude() - Method in class org.orekit.bodies.GeodeticPoint
Get the altitude.
getAltitude() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Getter for altitude.
getAltitude() - Method in class org.orekit.propagation.events.AltitudeDetector
Get the threshold altitude value.
getAncestor(int) - Method in class org.orekit.frames.Frame
Get the nth ancestor of the frame.
getAnelasticityCorrectionLoveNumber2() - Method in interface org.orekit.forces.gravity.tides.ITerrestrialTidesDataProvider
Get second degree Love number for the third body perturbation.
getAnelasticityCorrectionLoveNumber2() - Method in class org.orekit.forces.gravity.tides.TerrestrialTidesDataProvider
 
getAnelasticityCorrectionLoveNumber3() - Method in interface org.orekit.forces.gravity.tides.ITerrestrialTidesDataProvider
Get third degree Love number for the third body perturbation.
getAnelasticityCorrectionLoveNumber3() - Method in class org.orekit.forces.gravity.tides.TerrestrialTidesDataProvider
 
getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the angle of the rotation.
getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCone
 
getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
 
getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the angle of the rotation.
getAngle() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the angle of the line.
getAngle() - Method in class org.orekit.propagation.events.BetaAngleDetector
Returns beta angle triggering the event.
getAngleBewteen2Vector3D(Vector3D, Vector3D) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Computes the angle between 2 vectors 3D.
getAngleFromCosineAndSine(double, double) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Computes an angle from the sine and the cosine
getAngles(RotationOrder) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the Cardan or Euler angles corresponding to the instance.
getAngles(RotationOrder) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the Cardan or Euler angles corresponding to the instance.
getAngleU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
 
getAngleU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
 
getAngleV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
 
getAngleV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
 
getAngleX() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns the angle of the cone along X axis
getAngleY() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns the angle of the cone along Y axis
getAngular() - Method in class org.orekit.frames.transformations.Transform
Get the orientation and rotation rate of the "destination" frame in the "origin" one.
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) - Method in class fr.cnes.sirius.patrius.fieldsofview.CircularField
Computes the angular distance between a vector and the border of the field.
getAngularDistance(Vector3D) - 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) - 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
 
getAngularDistance(Vector3D) - 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.guidance.AngularVelocitiesHarmonicProfile
 
getAngularFrequencies() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
 
getAngularFrequency() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
 
getAngularVelocity() - Method in class org.orekit.utils.PVCoordinates
Get the angular velocity (spin) of this point as seen from the origin.
getAnomaly(PositionAngle) - Method in class org.orekit.orbits.ApsisOrbit
Get the anomaly.
getAnomaly(PositionAngle) - Method in class org.orekit.orbits.EquatorialOrbit
Get the anomaly.
getAnomaly(PositionAngle) - Method in class org.orekit.orbits.KeplerianOrbit
Get the anomaly.
getAnomaly(PositionAngle) - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Get the anomaly.
getAnomaly(PositionAngle) - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Get the anomaly.
getAnomaly(PositionAngle) - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Get the anomaly.
getAnomaly(PositionAngle) - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Get the anomaly.
getAnomaly() - Method in class org.orekit.propagation.events.AnomalyDetector
Get the anomaly to detect.
getAnomalyType() - Method in class org.orekit.propagation.events.AnomalyDetector
Get the type of anomaly to detect.
getAOL() - Method in class org.orekit.propagation.events.AOLDetector
Get the AOL to detect.
getAOLFrame() - Method in class org.orekit.propagation.events.AOLDetector
Get the reference frame.
getAolModel() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Get the argument of latitude parameter model.
getAOLType() - Method in class org.orekit.propagation.events.AOLDetector
Get the type of AOL to detect.
getAp(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.JB2006InputParameters
Get the Geomagnetic planetary 3-hour index Ap.
getAp() - Method in class org.orekit.forces.atmospheres.MSIS2000.ApCoef
Getter for AP.
getAp() - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Getter for ap.
getAp(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get Ap value at given user date
getAp(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get Ap value at given user date
getAp(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get Ap value at given user date
getAp(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get Ap value at given user date
getApA() - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Getter for apA.
getApertureX() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns the aperture of the cone along X axis
getApertureY() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns the aperture of the cone along Y axis
getApKpMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get maximum date of ap / kp values
getApKpMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get maximum date of ap / kp values
getApKpMaxDate() - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get maximum date of ap / kp values
getApKpMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get maximum date of ap / kp values
getApKpMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get minimum date of ap / kp values
getApKpMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get minimum date of ap / kp values
getApKpMinDate() - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get minimum date of ap / kp values
getApKpMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get minimum date of ap / kp values
getApKpValues(AbsoluteDate, AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get ap / kp values between the given dates
getApKpValues(AbsoluteDate, AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get ap / kp values between the given dates
getApKpValues(AbsoluteDate, AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get ap / kp values between the given dates
getApKpValues(AbsoluteDate, AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get ap / kp values between the given dates
getApoapsis() - Method in class org.orekit.orbits.ApsisOrbit
Get the apoapsis.
getApoapsis() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Get the apoapsis.
getApoapsisAltitude() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Get the apoapsis altitude.
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 org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double) - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double) - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double) - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double) - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double) - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double) - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double) - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisAltitudeParameters(double) - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Convert current orbital parameters into apsis (using altitude) parameters.
getApsisParameters() - Method in class org.orekit.orbits.ApsisOrbit
Getter for underlying apsis parameters.
getApsisRadiusParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters(double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters() - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApsisRadiusParameters() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Convert current orbital parameters into apsis (using radius) parameters.
getApValues(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.MSISE2000InputParameters
Get the array containing the 7 ap values
getApValues(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Get the array containing the 7 ap values
getApValues(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.ClassicalMSISE2000SolarData
Get the array containing the 7 ap values
getApValues(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.ContinuousMSISE2000SolarData
Get the array containing the 7 ap values
getArea() - Method in class fr.cnes.sirius.patrius.assembly.properties.features.Facet
 
getArgument() - Method in class org.apache.commons.math3.complex.Complex
Compute the argument of this complex number.
getArgument() - Method in exception org.apache.commons.math3.exception.MathIllegalNumberException
 
getArity() - Method in class org.apache.commons.math3.genetics.TournamentSelection
Gets the arity (number of chromosomes drawn to the tournament).
getArrayRef() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Provides direct access to the internal storage array.
getAssembly() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
 
getAssembly() - Method in class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Get the assembly.
getAssembly() - Method in class fr.cnes.sirius.patrius.events.sensor.SecondarySpacecraft
 
getAssembly() - Method in class fr.cnes.sirius.patrius.events.sensor.SensorInhibitionDetector
Get the assembly.
getAssembly() - Method in class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
Get the assembly.
getAssembly() - Method in class fr.cnes.sirius.patrius.events.sensor.StationToSatMutualVisibilityDetector
Get the assembly.
getAssembly() - Method in class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
Get the assembly.
getAtmosphericLoss(double) - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
Gets the atmospheric loss using a spline interpolation.
getAtmScaleHeight() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Get the atmospheric height scale factor.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesHarmonicProfile
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesPolynomialProfile
Compute the attitude corresponding to an orbital state.
getAttitude(Orbit) - Method in class fr.cnes.sirius.patrius.guidance.GuidanceProfile
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialProfile
Compute the attitude corresponding to an orbital state.
getAttitude(Orbit) - Method in class org.orekit.attitudes.AbstractAttitudeLaw
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.AbstractSlew
 
getAttitude(Orbit) - Method in class org.orekit.attitudes.AbstractSlew
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.AttitudeLawLeg
 
getAttitude(Orbit) - Method in class org.orekit.attitudes.AttitudeLawLeg
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.AttitudeLegLaw
Compute the attitude corresponding to an orbital state.
getAttitude(Orbit) - Method in class org.orekit.attitudes.AttitudeLegLaw
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Gets the attitude from the sequence.
The AttitudeLeg matching the date is called to compute the attitude.
getAttitude(Orbit) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in interface org.orekit.attitudes.AttitudeProvider
Compute the attitude corresponding to an orbital state.
getAttitude(Orbit) - Method in interface org.orekit.attitudes.AttitudeProvider
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.AttitudesSequence
Compute the attitude corresponding to an orbital state.
getAttitude(Orbit) - Method in class org.orekit.attitudes.AttitudesSequence
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.BodyCenterPointing
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.CelestialBodyPointed
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.ComposedAttitudeLaw
 
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.ConstantAttitudeLaw
Compute the attitude corresponding to an orbital state.
getAttitude(AbsoluteDate, Frame) - Method in class org.orekit.attitudes.ConstantSpinSlew
 
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.FixedRate
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.GroundPointing
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.InertialProvider
Deprecated. Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.LofOffset
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.LofOffsetPointing
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.RelativeTabulatedAttitudeLaw
Compute the attitude corresponding to an orbital state.
getAttitude(Orbit) - Method in class org.orekit.attitudes.RelativeTabulatedAttitudeLaw
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.RelativeTabulatedAttitudeLeg
Compute the attitude corresponding to an orbital state.
getAttitude(Orbit) - Method in class org.orekit.attitudes.RelativeTabulatedAttitudeLeg
Compute the attitude corresponding to an orbital state.
getAttitude(AbsoluteDate, Frame) - Method in interface org.orekit.attitudes.Slew
Compute the attitude.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.SpinStabilized
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.TabulatedAttitude
Compute the attitude corresponding to an orbital state.
getAttitude(Orbit) - Method in class org.orekit.attitudes.TabulatedAttitude
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.TargetPointing
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.TwoDirectionsAttitude
Compute the attitude corresponding to an orbital state.
getAttitude(AbsoluteDate, Frame) - Method in class org.orekit.attitudes.TwoSpinBiasSlew
 
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.YawCompensation
Compute the attitude corresponding to an orbital state.
getAttitude(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.YawSteering
Compute the attitude corresponding to an orbital state.
getAttitude() - Method in class org.orekit.propagation.SpacecraftState
Get the default attitude : the attitude for forces computation.
getAttitudeEvents() - Method in class org.orekit.propagation.SpacecraftState
Get the attitude for events computation.
getAttitudeForces() - Method in class org.orekit.propagation.SpacecraftState
Get the attitude for forces computation.
getAttitudeLaw() - Method in class org.orekit.attitudes.AttitudeFrame
 
getAttitudeLaw() - Method in class org.orekit.attitudes.AttitudeLawLeg
Gets the attitude law provider associated to the current attitude leg.
getAttitudeLeg(AbsoluteDate) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Gets the AttitudeLeg corresponding to the date.
getAttitudeLeg(String) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Get the attitude leg in the sequence with the selected code.
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
 
getAttitudeProvider() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Get attitude provider.
getAttitudeProvider() - Method in class org.orekit.propagation.AbstractPropagator
Get attitude provider.
getAttitudeProvider() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get attitude provider.
getAttitudeProvider() - Method in interface org.orekit.propagation.Propagator
Get attitude provider.
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
 
getAttitudeProviderEvents() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Get attitude provider for events computation.
getAttitudeProviderEvents() - Method in class org.orekit.propagation.AbstractPropagator
Get attitude provider for events computation.
getAttitudeProviderEvents() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get attitude provider for events computation.
getAttitudeProviderEvents() - Method in interface org.orekit.propagation.Propagator
Get attitude provider for events 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
 
getAttitudeProviderForces() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Get attitude provider for forces computation.
getAttitudeProviderForces() - Method in class org.orekit.propagation.AbstractPropagator
Get attitude provider for forces computation.
getAttitudeProviderForces() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get attitude provider for forces computation.
getAttitudeProviderForces() - Method in interface org.orekit.propagation.Propagator
Get attitude provider for forces computation.
getAttitudes() - Method in class org.orekit.attitudes.TabulatedAttitude
Get the non-interpolated and rightly ordered attitudes.
getAttitudeType() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAttitudeAdditionalEquations
Get the attitude type.
getAttitudeType() - Method in class org.orekit.propagation.numerical.AttitudeEquation
Get the attitude type.
getAttribute() - Method in class org.apache.commons.math3.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.
getAvailableLocales() - Static method in class org.apache.commons.math3.complex.ComplexFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.fraction.FractionFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.geometry.VectorFormat
Get the set of locales for which point/vector formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the set of locales for which real vectors formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math3.linear.RealVectorFormat
Get the set of locales for which real vectors formats are available.
getAvailableParameters() - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Get the names of the available parameters in the propagator.
getAvailableSatelliteNumbers() - Method in class org.orekit.propagation.analytical.tle.TLESeries
Get the available satellite numbers.
getAverageFlux(AbsoluteDate, AbsoluteDate, SolarActivityDataProvider) - Static method in class org.orekit.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 org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the normalized axis of the rotation.
getAxis() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
 
getAxis() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCone
 
getAxis() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the normalized axis of the rotation.
getAxis1() - Method in class org.orekit.propagation.events.DihedralFieldOfViewDetector
Get the direction of fov 1st dihedral axis.
getAxis2() - Method in class org.orekit.propagation.events.DihedralFieldOfViewDetector
Get the direction of fov 2nd dihedral axis.
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() - Method in class fr.cnes.sirius.patrius.projections.Mercator
Get the azimuth of the projection (CLOCKWISE).
getAzimuth(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the azimuth of a point with regards to the topocentric frame center point.
getAzimuth() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Getter for azimuth of velocity.
getAzimuth() - Method in class org.orekit.utils.TopocentricPosition
Get the azimuth angle.
getAzimuth() - Method in class org.orekit.utils.TopocentricPV
Get the azimuth angle.
getAzimuthRate(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the azimuth rate of a point.
getAzimuthRate() - Method in class org.orekit.utils.TopocentricPV
Get the azimuth rate.
getB() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Get array of sine coefficients
getB(int, double) - Method in class org.apache.commons.math3.util.ContinuedFraction
Access the n-th b coefficient of the continued fraction.
getBalmino(EarthGravitationalModelFactory.GravityFieldNames, int, int) - Static method in class org.orekit.forces.gravity.EarthGravitationalModelFactory
Create an instance of a central body attraction with normalized coefficients and Helmholtz Polynomials (Balmino model).
getBarycenter() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Get the barycenter of the interval.
getBarycenter() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the barycenter of the instance.
getBarycenter() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the barycenter of the instance.
getBaseState(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.GroundPointingWrapper
Compute the base system state at given date, without compensation.
getBasicDimension() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get state vector dimension without additional parameters.
getBeta() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Access the second shape parameter, beta.
getBeta() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Deprecated. as of version 3.1, GammaDistribution.getScale() should be preferred. This method will be removed in version 4.0.
getBiggerLength() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Get the polygon's bigger length, i.e.
getBinCount() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns the number of bins.
getBinStats() - Method in class org.apache.commons.math3.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
 
getBody(String) - Static method in class org.orekit.bodies.CelestialBodyFactory
Get a celestial body.
getBody() - Method in class org.orekit.propagation.events.DistanceDetector
Returns the body.
getBody() - Method in class org.orekit.propagation.events.ExtremaDistanceDetector
 
getBodyFrame() - Method in class org.orekit.attitudes.GroundPointing
Get the body frame.
getBodyFrame() - Method in interface org.orekit.bodies.BodyShape
Get body frame related to body shape.
getBodyFrame() - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
 
getBodyFrame() - Method in class org.orekit.bodies.OneAxisEllipsoid
Get the body frame related to body shape.
getBodyFrame() - Method in class org.orekit.propagation.events.ExtremaLatitudeDetector
Returns the body frame.
getBodyFrame() - Method in class org.orekit.propagation.events.ExtremaLongitudeDetector
Returns the body frame.
getBodyFrame() - Method in class org.orekit.propagation.events.LocalTimeDetector
Get frame of the body.
getBodyFrame() - Method in class org.orekit.propagation.events.LongitudeDetector
Returns central body frame.
getBodyOrientedFrame() - Method in class org.orekit.bodies.AbstractCelestialBody
Get a body oriented, body centered frame.
getBodyOrientedFrame() - Method in interface org.orekit.bodies.CelestialBody
Get a body oriented, body centered frame.
getBodyShape() - Method in class org.orekit.attitudes.GroundPointing
Get the body shape.
getBodyShape() - Method in class org.orekit.propagation.events.AltitudeDetector
Get the body shape.
getBoundarySize() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the size of the boundary.
getBoundarySize() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the size of the boundary.
getBoundIsAllowed() - Method in exception org.apache.commons.math3.exception.NumberIsTooLargeException
 
getBoundIsAllowed() - Method in exception org.apache.commons.math3.exception.NumberIsTooSmallException
 
getBracketingStep() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.BracketingStep
Gets the initial step.
getBStar() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the ballistic coefficient.
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(int, int, boolean) - Method in interface org.orekit.forces.gravity.potential.PotentialCoefficientsProvider
Get the tesseral-sectorial and zonal coefficients.
getC(int, int, boolean) - Method in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Get the tesseral-sectorial and zonal coefficients.
getC() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
 
getC1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getC2() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getC3() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getC4() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getCacheSlotsNumber() - Static method in class org.orekit.utils.OrekitConfiguration
Get the number of slots to use in caches.
getCalendarWeek() - Method in class org.orekit.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 org.orekit.propagation.numerical.NumericalPropagator
Get the number of calls to the differential equations computation method.
getCallThreadName() - Method in class fr.cnes.sirius.validate.parallel.AbstractSimpleParallelTaskImpl
 
getCapacity() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Gets the currently allocated size of the internal data structure used for storing elements.
getCapitalizedAbbreviation() - Method in enum org.orekit.time.Month
Get the capitalized three letters abbreviation.
getCapitalizedName() - Method in enum org.orekit.time.Month
Get the capitalized full name.
getCardanMountPosition() - Method in class org.orekit.utils.CardanMountPV
Get the Cardan mount position.
getCartesian() - Method in class org.orekit.frames.transformations.Transform
Get the position and velocity of the "destination" frame in the "origin" one.
getCartesianCoordinates(double, double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Convert from Ellipsoid to Cartesian coordinates
getCartesianParameters() - Method in class org.orekit.orbits.CartesianOrbit
Getter for underlying circular parameters.
getCartesianParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Convert current orbital parameters into cartesian parameters.
getCartesianParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Convert current orbital parameters into cartesian parameters.
getCartesianParameters() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into cartesian parameters.
getCartesianParameters() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Convert current orbital parameters into cartesian parameters.
getCartesianParameters() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Convert current orbital parameters into cartesian parameters.
getCartesianParameters() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Convert current orbital parameters into cartesian parameters.
getCartesianParameters() - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Convert current orbital parameters into cartesian parameters.
getCartesianParameters() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Convert current orbital parameters into cartesian parameters.
getCartesianParameters() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Convert current orbital parameters into cartesian parameters.
getCartesianParameters() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Convert current orbital parameters into cartesian parameters.
getCc() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
 
getCcm() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getCcp() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getCd(Vector3D) - Method in class fr.cnes.sirius.patrius.stela.forces.drag.StelaCd
Compute the value of the Cd coefficient depending on spacecraft altitude.
getCell(Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the cell to which a point belongs.
getCenter() - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
 
getCenter() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Get ellipsoid center
getCenter() - Method in interface org.apache.commons.math3.geometry.euclidean.threed.IEllipsoid
Get ellipsoids' center
getCenter() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
 
getCenter() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getCenter() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
 
getCenter() - Method in class org.apache.commons.math3.stat.clustering.Cluster
Get the point chosen to be the center of this cluster.
getCenter() - Method in class org.orekit.propagation.events.CircularFieldOfViewDetector
Get the direction of fov center.
getCenter() - Method in class org.orekit.propagation.events.DihedralFieldOfViewDetector
Get the direction of fov center.
getCenteredModel() - Method in class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Get model for centered part of analytical model.
getCenteredValue(AbsoluteDate) - Method in class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Get the centered value of the model.
getCenters() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of the centers array.
getCentralBodyShape() - Method in class fr.cnes.sirius.patrius.events.EarthZoneDetector
Get the central body shape.
getCentralEccentricity() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
Getter for the central eccentricity ec.
getCheck() - Method in class org.apache.commons.math3.linear.ConjugateGradient
Returns true if positive-definiteness should be checked for both matrix and preconditioner.
getCheck() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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.
getChiSquare() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. 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 org.apache.commons.math3.genetics.ListPopulation
Access the list of chromosomes.
getChromosomes() - Method in class org.apache.commons.math3.genetics.ListPopulation
Returns an unmodifiable list of the chromosomes in this population.
getCIPMotion(AbsoluteDate) - Method in interface org.orekit.frames.configuration.FramesConfiguration
Compute the corrected Celestial Intermediate Pole motion (X, Y, S) in the GCRS.
getCIPMotion(AbsoluteDate) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Compute the corrected Celestial Intermediate Pole motion (X, Y, S) in the GCRS.
getCIPMotion() - Method in class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
Get CIP motion.
getCIPMotion(AbsoluteDate) - Method in class org.orekit.frames.configuration.PrecessionNutation
Compute the CIP pole coordinates at given date.
getCIPMotion(AbsoluteDate) - Method in class org.orekit.frames.configuration.precessionnutation.IERS20032010PrecessionNutation
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotion(AbsoluteDate) - Method in class org.orekit.frames.configuration.precessionnutation.NoPrecessionNutation
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotion(AbsoluteDate) - Method in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationCache
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotion(AbsoluteDate) - Method in interface org.orekit.frames.configuration.precessionnutation.PrecessionNutationModel
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotion(AbsoluteDate) - Method in class org.orekit.frames.configuration.precessionnutation.StelaPrecessionNutationModel
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotionTimeDerivative(AbsoluteDate) - Method in interface org.orekit.frames.configuration.FramesConfiguration
Compute the time derivative Celestial Intermediate Pole motion in the GCRS.
getCIPMotionTimeDerivative(AbsoluteDate) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Compute the time derivative Celestial Intermediate Pole motion in the GCRS.
getCIPMotionTimeDerivative(AbsoluteDate) - Method in class org.orekit.frames.configuration.PrecessionNutation
Compute the CIP pole coordinate derivatives at given date.
getCIPMotionTimeDerivative(AbsoluteDate) - Method in class org.orekit.frames.configuration.precessionnutation.IERS20032010PrecessionNutation
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotionTimeDerivative(AbsoluteDate) - Method in class org.orekit.frames.configuration.precessionnutation.NoPrecessionNutation
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotionTimeDerivative(AbsoluteDate) - Method in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationCache
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotionTimeDerivative(AbsoluteDate) - Method in interface org.orekit.frames.configuration.precessionnutation.PrecessionNutationModel
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotionTimeDerivative(AbsoluteDate) - Method in class org.orekit.frames.configuration.precessionnutation.StelaPrecessionNutationModel
Compute the Celestial Intermediate pole motion in the GCRS.
getCIPMotionTimeDerivatives() - Method in class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
Get CIP motion time derivatives.
getCircuitLoss() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
 
getCircularEx() - Method in class org.orekit.orbits.CircularOrbit
Get the first component of the circular eccentricity vector.
getCircularEx() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Get the first component of the circular eccentricity vector.
getCircularEy() - Method in class org.orekit.orbits.CircularOrbit
Get the second component of the circular eccentricity vector.
getCircularEy() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Get the second component of the circular eccentricity vector.
getCircularFOVDetector() - Method in class fr.cnes.sirius.patrius.events.CentralBodyMaskCircularFOVDetector
Get the circular FOV detector.
getCircularParameters() - Method in class org.orekit.orbits.CircularOrbit
Getter for underlying circular parameters.
getCircularParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Convert current orbital parameters into circular parameters.
getCircularParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Convert current orbital parameters into circular parameters.
getCircularParameters() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into circular parameters.
getCircularParameters(double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into circular parameters.
getCircularParameters() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Convert current orbital parameters into circular parameters.
getCircularParameters() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Convert current orbital parameters into circular parameters.
getCircularParameters() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Convert current orbital parameters into circular parameters.
getCircularParameters() - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Convert current orbital parameters into circular parameters.
getCircularParameters() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Convert current orbital parameters into circular parameters.
getCircularParameters() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Convert current orbital parameters into circular parameters.
getCircularParameters() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Convert current orbital parameters into circular parameters.
getCIRF() - Static method in class org.orekit.frames.FramesFactory
Get the CIRF reference frame.
getClassification() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
 
getClassification() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the classification.
getClockCorrection() - Method in class org.orekit.files.general.SatelliteTimeCoordinate
Returns the clock correction value.
getClockRateChange() - Method in class org.orekit.files.general.SatelliteTimeCoordinate
Returns the clock rate change value.
getClosestTLE(AbsoluteDate) - Method in class org.orekit.propagation.analytical.tle.TLESeries
Get the closest TLE to the selected date.
getCm() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getCode() - Method in class fr.cnes.sirius.patrius.events.CodedEvent
 
getCode() - Method in class fr.cnes.sirius.patrius.events.Phenomenon
 
getCodedEvent() - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger.LoggedCodedEvent
Gets the coded event.
getCodedEvent() - Method in class fr.cnes.sirius.patrius.events.multi.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.CodedEventsLogger
Gets the CodedEventsList.
getCodedEventsList() - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger
Gets the CodedEventsList.
getCodedEventsList() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
 
getCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
 
getCoefficients() - Method in class org.apache.commons.math3.optim.linear.LinearConstraint
Gets the coefficients of the constraint (left hand side).
getCoefficients() - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
Gets the coefficients of the linear equation being optimized.
getCoefficients() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated. Get the coefficients of the constraint (left hand side).
getCoefficients() - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated. Get the coefficients of the linear equation being optimized.
getCoefficientsProvider() - Static method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsFactory
Get the ocean tides coefficients provider from the first supported file.
getCoefPoly() - Method in class org.orekit.propagation.analytical.twod.DatePolynomialFunction
Returns a copy of polynomial development coefficients.
getColumn(int) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Data
Gets a column.
getColumn(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given column index as an array.
getColumn(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given column index as an array.
getColumn(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in column number col as an array.
getColumn() - Method in exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
 
getColumn() - Method in exception org.apache.commons.math3.linear.NonSymmetricMatrixException
 
getColumn(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given column index as an array.
getColumnDimension() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - Method in interface org.apache.commons.math3.linear.AnyMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the number of columns of this matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the number of columns of this matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
Returns the dimension of the domain of this operator.
getColumnDimension() - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Returns the number of columns of this matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns the dimension of the domain of this operator.
getColumnDimension() - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns the number of columns of this matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given column index as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given column index as a column matrix.
getColumnMatrix(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given column index as a column matrix.
getColumnNumber() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Data
Gets the number of columns.
getColumnSeparator() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format separator between components.
getColumnTitles() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
get the titles of the columns.
getColumnVector(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given column index as a vector.
getColumnVector(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given column index as a vector.
getColumnVector(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given column index 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.CodedEvent
 
getComment() - Method in class fr.cnes.sirius.patrius.events.Phenomenon
 
getCompensation(PVCoordinatesProvider, AbsoluteDate, Frame, Attitude) - Method in class org.orekit.attitudes.GroundPointingWrapper
Compute the TimeStampedAngularCoordinates at a given time.
getCompensation(PVCoordinatesProvider, AbsoluteDate, Frame, Attitude) - Method in class org.orekit.attitudes.YawCompensation
Compute the TimeStampedAngularCoordinates at a given time.
getCompensation(PVCoordinatesProvider, AbsoluteDate, Frame, Attitude) - Method in class org.orekit.attitudes.YawSteering
Compute the TimeStampedAngularCoordinates at a given time.
getCompiler(int, int) - Static method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the compiler for number of free parameters and order.
getComplement(Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Get the complement of the region (exchanged interior/exterior).
getComplementaryIntervals() - Method in class org.orekit.utils.AbsoluteDateIntervalsList
Gets the list of complementary intervals of the given list of intervals.
getCompleteState() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get the complete current state.
getComponents() - Method in class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Gets the distributions that make up the mixture model.
getComponents() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
Get the components array.
getComponents(TimeScale) - Method in class org.orekit.time.AbsoluteDate
Split the instance into date/time components.
getConditionNumber() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Return the condition number of the matrix.
getConfiguration() - Method in class org.orekit.frames.configuration.FramesConfigurationBuilder
Configuration builder using the current builder providers.
getConfiguration() - Static method in class org.orekit.frames.FramesFactory
Getter for the current configuration.
getConjugate() - Method in class org.apache.commons.math3.complex.Quaternion
Returns the conjugate quaternion of the instance.
getConjugateRadius() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Spheroid
Get conjugate radius of Spheroid
getConjugateRadius() - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
Return conjugate radius (minor semi axis)
getConstant() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
 
getConstants() - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesHarmonicProfile
 
getConstants() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
 
getConstantTerm() - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
Gets the constant of the linear equation being optimized.
getConstantTerm() - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated. Get the constant of the linear equation being optimized.
getConstraints() - Method in class org.apache.commons.math3.optim.linear.LinearConstraintSet
Gets the set of linear constraints.
getConstraints() - Method in class org.apache.commons.math3.optim.linear.LinearOptimizer
 
getConstraints() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated.  
getContext() - Method in exception org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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.
getContractionCriteria() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Please use ResizableDoubleArray.getContractionCriterion() instead.
getContractionCriterion() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.filter.DefaultProcessModel
Returns the control matrix.
getControlMatrix() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the control matrix.
getConvention() - Method in class org.apache.commons.math3.utils.AbstractSearchIndex
Returns the convention that can be applied to the interval during the search index algorithm.
getConvention() - Method in interface org.apache.commons.math3.utils.ISearchIndex
Returns the convention that can be applied to the interval during the search index algorithm.
getConvergence() - Method in class org.apache.commons.math3.ode.events.EventState
Get the convergence threshold for event localization.
getConvergenceChecker() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated. Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated. Get the convergence checker.
getConvergenceChecker() - Method in interface org.apache.commons.math3.optimization.BaseOptimizer
Deprecated. Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated. Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated. Get the convergence checker.
getCoordinate() - Method in class org.orekit.files.general.SatelliteTimeCoordinate
Returns the coordinate of this entry.
getCoordinateSystem() - Method in interface org.orekit.files.general.OrbitFile
Returns the coordinate system of the entries in this orbit file.
getCoordinateSystem() - Method in class org.orekit.files.sp3.SP3File
Returns the coordinate system of the entries in this orbit file.
getCorners() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
 
getCorrectedVector(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.sensor.AbstractDetectorWithTropoCorrection
Compute the apparent vector from the station to the spacecraft with tropospheric effects.
getCorrection() - Method in class fr.cnes.sirius.patrius.events.sensor.AbstractDetectorWithTropoCorrection
Get the correction.
getCorrectionsFromGeometricElevation(double) - Method in class fr.cnes.sirius.patrius.signalpropagation.AzoulayModel
Computes the corrections due to the troposphere from the geometric value of the elevation.
getCorrectionsFromTrueElevation(double) - Method in class fr.cnes.sirius.patrius.signalpropagation.AzoulayModel
Computes the corrections due to the troposphere from the TRUE value of the elevation.
getCorrelationMatrix() - Method in class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Returns the correlation matrix
getCorrelationMatrix() - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Calculate the Spearman Rank Correlation Matrix.
getCorrelationPValues() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Returns a matrix of standard errors associated with the estimates in the correlation matrix.
getCorrelationStandardErrors().getEntry(i,j) is the standard error associated with getCorrelationMatrix.getEntry(i,j)
getCosArray() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
 
getCosArrays() - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesHarmonicProfile
 
getCosArrays() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
 
getCount(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values = v.
getCount(int) - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values = v.
getCount(long) - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values = v.
getCount(char) - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values = v.
getCount() - Method in class org.apache.commons.math3.util.Incrementor
Gets the current count.
getCount(int...) - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Convert to unidimensional counter.
getCount() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
Get the current unidimensional counter slot.
getCount(int) - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
Get the current count in the selected dimension.
getCounts(int) - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Convert to multidimensional counter.
getCounts() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
Get the current multidimensional counter slots.
getCovariance(double) - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the n × n covariance matrix.
getCovariance(int, int) - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
Get the covariance for an individual element of the covariance matrix.
getCovariance() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the covariance matrix of the values that have been added.
getCovariance() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns the covariance of the available values.
getCovariance() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the covariance matrix of the values that have been added.
getCovarianceMatrix() - Method in class org.apache.commons.math3.stat.correlation.Covariance
Returns the covariance matrix
getCovarianceMatrix() - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
Returns the covariance matrix
getCovarianceMatrix() - Method in class org.orekit.propagation.analytical.covariance.OrbitCovariance
Covariance matrix getter.
getCovarianceMatrix(Orbit, OrbitType, Frame) - Method in class org.orekit.propagation.analytical.covariance.OrbitCovariance
Covariance matrix getter.
getCovarianceOfParameters(int, int) - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the covariance between regression parameters i and j.
getCovariances() - Method in class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Gets the covariance matrix.
getCovariances() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1. Please use AbstractLeastSquaresOptimizer.computeCovariances(double[],double) instead.
getCovariances(double) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1. Please use AbstractLeastSquaresOptimizer.computeCovariances(double[],double) instead.
getCp() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getCpmEpm(double, int, int) - Method in interface org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
Get the Clm± and εlm± for given wave
getCpmEpm(double, int, int) - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Get the Clm± and εlm± for given wave
getCpmEpm(double, int, int) - Method in class org.orekit.forces.gravity.tides.OceanTidesDataProvider
 
getCpmSpm(double, int, int) - Method in interface org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
Get the Clm± and Slm± for given wave
getCpmSpm(double, int, int) - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Get the Clm± and Slm± for given wave
getCpmSpm(double, int, int) - Method in class org.orekit.forces.gravity.tides.OceanTidesDataProvider
 
getCrossoverPoints() - Method in class org.apache.commons.math3.genetics.NPointCrossover
Returns the number of crossover points used by this CrossoverPolicy.
getCrossoverPolicy() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the crossover policy.
getCrossoverRate() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the crossover rate.
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
 
getCrossSection(Vector3D) - Method in interface org.apache.commons.math3.geometry.euclidean.threed.CrossSectionProvider
Computes the cross section from the direction defined by a Vector3D.
getCrossSection(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
Computes the cross section from the direction defined by a Vector3D.
getCrossSection(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
Computes the cross section from the direction defined by a Vector3D.
getCrossSection(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Computes the cross section from the direction defined by a Vector3D.
getCsm() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getCsp() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getCumFreq(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(int) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(long) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(char) - Method in class org.apache.commons.math3.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumPct(Comparable<?>) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCunningham(EarthGravitationalModelFactory.GravityFieldNames, int, int) - Static method in class org.orekit.forces.gravity.EarthGravitationalModelFactory
Create an instance of the gravitational field of a celestial body using Cunningham model.
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.MultiOrekitStepInterpolator
Get the current grid date.
getCurrentDate() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
Get the current grid date.
getCurrentDate() - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Get the current grid date.
getCurrentDate() - Method in class org.orekit.propagation.sampling.BasicStepInterpolator
Get the current grid date.
getCurrentDate() - Method in interface org.orekit.propagation.sampling.OrekitStepInterpolator
Get the current grid date.
getCurrentMainSetJacobian(double[][]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Get the current value of the Jacobian matrix with respect to state.
getCurrentOccurrence() - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Get the current occurrence (during propagation).
getCurrentParameterJacobian(String, double[]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Get the current value of the Jacobian matrix with respect to one parameter.
getCurrentSignedStepsize() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the current signed value of the integration stepsize.
getCurrentStepStart() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the current value of the step start time ti.
getCurrentTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the current soft grid point time.
getCurrentTime() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the current grid point time.
getCut() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.linear.EigenDecomposition
Gets the block diagonal matrix D of the decomposition.
getD() - Method in interface org.apache.commons.math3.linear.UDDecomposition
Returns the matrix D of the decomposition.
getD() - Method in class org.apache.commons.math3.linear.UDDecompositionImpl
get the D matrix
getD() - Method in class org.orekit.data.BodiesElements
Get the mean elongation of the Moon from the Sun.
getD() - Method in class org.orekit.forces.atmospheres.MSIS2000.Output
Getter for density (d).
getD(int) - Method in class org.orekit.forces.atmospheres.MSIS2000.Output
Getter for density component.
getData(AbsoluteDate, double) - Method in class fr.cnes.sirius.patrius.signalpropagation.iono.USKLoader
Returns the USK data for the Bent model.
getData(AbsoluteDate, double) - Method in interface fr.cnes.sirius.patrius.signalpropagation.iono.USKProvider
Returns the USK data for the Bent model.
getData(BufferedReader) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.AbstractDataLoader
parses the text reader to a Data object.
getData(BufferedReader) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.PSimuDataLoader
Reads the data through the BufferedReader.
getData() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
 
getData() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns vector entries as a T array.
getData() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in interface org.apache.commons.math3.linear.FieldVector
Deprecated. as of 3.1, to be removed in 4.0. Please use the FieldVector.toArray() method instead.
getData() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. as of 3.1, to be removed in 4.0. Please use the SparseFieldVector.toArray() method instead.
getData() - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
Return the covariance matrix as two-dimensional array.
getData() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Get a copy of the stored data array.
getData() - Method in interface org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
Get the normalized variable potential coefficients
getData() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Get the normalized variable potential coefficients
getDataAsArray() - Method in interface fr.cnes.sirius.validate.parallel.ParallelResult
Gets the result data as an array of arrays.
getDataLocation() - Method in enum org.orekit.frames.configuration.precessionnutation.PrecessionNutationConvention
Get the location of the data for the selected convention.
getDataRef() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Get a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Get a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Get a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Gets a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Get a reference to the stored data array.
getDataUsed() - Method in class org.orekit.files.sp3.SP3File
Returns the data used indicator from the SP3 file.
getDate() - Method in class fr.cnes.sirius.patrius.events.CodedEvent
 
getDate() - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger.LoggedCodedEvent
 
getDate() - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger.MultiLoggedCodedEvent
 
getDate(int, double) - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
Returns GNSS date given a week number and second in the week.
getDate(int, double) - Method in class fr.cnes.sirius.patrius.utils.GalileoAlmanacParameters
 
getDate(int, double) - Method in class fr.cnes.sirius.patrius.utils.GPSAlmanacParameters
 
getDate() - Method in class org.orekit.attitudes.Attitude
Get the date of attitude parameters.
getDate() - Method in class org.orekit.bodies.PosVelChebyshev
Get the date.
getDate() - Method in class org.orekit.files.general.SatelliteTimeCoordinate
Get the date.
getDate() - Method in interface org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
Get the reference date of the file
getDate() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
 
getDate() - Method in class org.orekit.forces.maneuvers.SmallManeuverAnalyticalModel
Get the date of the maneuver.
getDate() - Method in class org.orekit.frames.configuration.eop.EOPEntry
Get the date.
getDate() - Method in class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
Get the date.
getDate() - Method in class org.orekit.frames.configuration.tides.TidalCorrection
 
getDate() - Method in class org.orekit.frames.transformations.Transform
Get the date.
getDate() - Method in class org.orekit.orbits.Orbit
Get the date of orbital parameters.
getDate() - Method in class org.orekit.propagation.analytical.covariance.OrbitCovariance
Get the date.
getDate() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the TLE current date.
getDate() - Method in class org.orekit.propagation.events.DateDetector
Get the current event date according to the propagator.
getDate() - Method in class org.orekit.propagation.SpacecraftState
Get the date.
getDate() - Method in class org.orekit.time.AbsoluteDate
Get the date.
getDate() - Method in class org.orekit.time.DateTimeComponents
Get the date component.
getDate() - Method in interface org.orekit.time.TimeStamped
Get the date.
getDate() - Method in class org.orekit.utils.TimeStampedAngularCoordinates
Get the date.
getDate() - Method in class org.orekit.utils.TimeStampedPVCoordinates
Get the date.
getDateIntervals() - Method in class org.orekit.propagation.analytical.twod.AbstractDateIntervalFunction
Returns a copy of date intervals.
getDateRef() - Method in class org.orekit.utils.AbstractBoundedPVProvider
Get the reference date
getDates() - Method in class fr.cnes.sirius.patrius.tools.force.validation.PVEphemerisLoader
Give the list of dates which have been read.
getDateZero() - Method in class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
Get the date zero of the polynomial functions.
getDay() - Method in class org.orekit.time.DateComponents
Get the day.
getDayFraction() - Method in class org.orekit.files.sp3.SP3File
Returns the day fraction for this SP3 file.
getDayOfWeek() - Method in class org.orekit.time.DateComponents
Get the day of week.
getDayOfYear() - Method in class org.orekit.time.DateComponents
Get the day number in year.
getDdeps() - Method in class org.orekit.frames.configuration.eop.NutationCorrection
Get the δΔε1980 parameter.
getDdpsi() - Method in class org.orekit.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
getDecimalDigits() - Method in class org.apache.commons.math3.dfp.DfpDec
Get the number of decimal digits this class is going to represent.
getDecimalYear(AbsoluteDate) - Static method in class org.orekit.models.earth.GeoMagneticField
Utility function to get a decimal year for a given AbsoluteDate.
getDecimalYear(int, int, int) - Static method in class org.orekit.models.earth.GeoMagneticField
Utility function to get a decimal year for a given day.
getDeclination() - Method in class org.orekit.models.earth.GeoMagneticElements
Returns the declination of the magnetic field in degrees.
getDecreasingTimeShift() - Method in class org.orekit.propagation.events.EventShifter
Get the decreasing events time shift.
getDefaultModel(double) - Static method in class org.orekit.models.earth.FixedDelayModel
Returns the default model, loading delay values from the file "tropospheric-delay.txt".
getDefaultNumberFormat() - Static method in class org.apache.commons.math3.fraction.AbstractFormat
Create a default number format.
getDefaultNumberFormat(Locale) - Static method in class org.apache.commons.math3.fraction.AbstractFormat
Create a default number format.
getDefaultNumberFormat() - Static method in class org.apache.commons.math3.fraction.FractionFormat
Create a default number format.
getDefaultNumberFormat() - Static method in class org.apache.commons.math3.util.CompositeFormat
Create a default number format.
getDefaultNumberFormat(Locale) - Static method in class org.apache.commons.math3.util.CompositeFormat
Create a default number format.
getDegree() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Get polynomial degree
getDegree() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getDegree() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
 
getDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Access the number of degrees of freedom.
getDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.TDistribution
Access the degrees of freedom.
getDelta() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the elevation of the vector.
getDelta() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the elevation of the vector.
getDeltaEccentricity() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
Getter for the delta eccentricity Δe.
getDeltaVSat() - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Get the velocity increment in satellite frame.
getDenominator() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the denominator as a BigInteger.
getDenominator() - Method in class org.apache.commons.math3.fraction.Fraction
Access the denominator.
getDenominatorAsInt() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the denominator as a int.
getDenominatorAsLong() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the denominator as a long.
getDenominatorDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.FDistribution
Access the denominator degrees of freedom.
getDenominatorFormat() - Method in class org.apache.commons.math3.fraction.AbstractFormat
Access the denominator format.
getDenormalizedCCoefs(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.OceanTides
Get denormalized C coefficients table
getDenormalizedSCoefs(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.OceanTides
Get denormalized S coefficients table
getDensity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.MSIS00Adapter
Get the local density.
getDensity(AbsoluteDate, Vector3D, Frame) - Method in interface org.orekit.forces.atmospheres.Atmosphere
Get the local density.
getDensity(double, double, double, double, double, double, double, double, double) - Method in class org.orekit.forces.atmospheres.DTM2000
Get the local density with initial entries.
getDensity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.DTM2000
Get the local density.
getDensity(double, double, Vector3D, double) - Method in class org.orekit.forces.atmospheres.HarrisPriester
Get the local density.
getDensity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.HarrisPriester
Get the local density.
getDensity(double, double, double, double, double, double, double, double, double, double, double, double, double) - Method in class org.orekit.forces.atmospheres.JB2006
Get the local density with initial entries.
getDensity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.JB2006
Get the local density.
getDensity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.MSISE2000
Get the local density.
getDensity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.SimpleExponentialAtmosphere
Get the local density.
getDensity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.US76
Get the local density for altitude in interval [0, 1E6] m
getDepth() - Method in class org.orekit.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.
getDetector() - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger.LoggedCodedEvent
Gets the CodingEventDetector that generated the coded event.
getDetector1() - Method in class fr.cnes.sirius.patrius.events.CombinedPhenomenaDetector
Returns first detector.
getDetector2() - Method in class fr.cnes.sirius.patrius.events.CombinedPhenomenaDetector
Returns second detector.
getDeterminant() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
Return the determinant of the matrix
getDeterminant() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Computes the determinant of the matrix.
getDeterminant() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Return the determinant of the matrix.
getDeterminant() - Method in class org.apache.commons.math3.linear.LUDecomposition
Return the determinant of the matrix
getDeterminant() - Method in interface org.apache.commons.math3.linear.UDDecomposition
Return the determinant of the matrix
getDeterminant() - Method in class org.apache.commons.math3.linear.UDDecompositionImpl
get the determinant
getDevelopmentOrders() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Return the array with models trigonometric orders.
getDiagonalOfHatMatrix(double[]) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Gets the diagonal of the Hat matrix also known as the leverage matrix.
getDifferentiator() - Method in class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Get the differentiator.
getDifferentiator() - Method in class org.orekit.attitudes.kinematics.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 - τ).
getDimension() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaDifferentialEquations
 
getDimension() - Method in class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
Gets the number of random variables of the distribution.
getDimension() - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Gets the number of random variables of the distribution.
getDimension() - Method in exception org.apache.commons.math3.exception.DimensionMismatchException
 
getDimension() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D
Get the dimension of the space.
getDimension() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D
Get the dimension of the space.
getDimension() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D
Get the dimension of the space.
getDimension() - Method in interface org.apache.commons.math3.geometry.Space
Get the dimension of the space.
getDimension() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns the size of the vector.
getDimension() - Method in interface org.apache.commons.math3.linear.FieldVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.linear.RealVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math3.ode.EquationsMapper
Get the dimension of the secondary state parameters.
getDimension() - Method in class org.apache.commons.math3.ode.FirstOrderConverter
Get the dimension of the problem.
getDimension() - Method in interface org.apache.commons.math3.ode.FirstOrderDifferentialEquations
Get the dimension of the problem.
getDimension() - Method in interface org.apache.commons.math3.ode.SecondaryEquations
Get the dimension of the secondary state parameters.
getDimension() - Method in interface org.apache.commons.math3.ode.SecondOrderDifferentialEquations
Get the dimension of the problem.
getDimension() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get simplex dimension.
getDimension() - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Get simplex dimension.
getDimension() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the dimension of the data
getDimension() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns the dimension of the data
getDimension() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the dimension of the data
getDimension() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Get the number of dimensions of the multidimensional counter.
getDirection() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
 
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
 
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
 
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
This method returns the main axis of the cylinder
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
 
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
 
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get the normalized direction vector.
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.LineSegment
 
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
 
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
 
getDirection() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
 
getDirection(SpacecraftState) - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Get the thrust direction.
getDirFlux() - Method in class org.orekit.forces.radiation.ElementaryFlux
get the direction flux
getDistance(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Distance between two vectors.
getDistance(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Optimized method to compute distance.
getDistance(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Distance between two vectors.
getDistance(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Distance between two vectors.
getDistance() - Method in class org.orekit.propagation.events.DistanceDetector
Returns the distance triggering the event.
getDistortionFactor(double) - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Returns the scale factor at a specific latitude.
getDistortionFactor(double) - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
Returns the scale factor at a specific latitude.
getDistortionFactor(double) - Method in class fr.cnes.sirius.patrius.projections.Mercator
Returns the scale factor at a specific latitude.
getDiurnalRotationModel() - Method in interface org.orekit.frames.configuration.FramesConfiguration
Get the diurnal rotation model.
getDiurnalRotationModel() - Method in class org.orekit.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 org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getDoodsonNumbers() - Method in interface org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
Get available Doodson numbers
getDoodsonNumbers() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Get available Doodson numbers
getDoodsonNumbers() - Method in interface org.orekit.forces.gravity.tides.ITerrestrialTidesDataProvider
Get the Doodson numbers used by the standard.
getDoodsonNumbers() - Method in class org.orekit.forces.gravity.tides.OceanTidesDataProvider
 
getDoodsonNumbers() - Method in class org.orekit.forces.gravity.tides.TerrestrialTidesDataProvider
 
getDoy() - Method in class org.orekit.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 org.apache.commons.math3.analysis.polynomials.HelmholtzPolynomial
Get the H'lm coefficients
getDragCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
Get the drag coefficient
getDragForce() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Get the drag force coefficient parametrizable function.
getDragForceDerivativeValue(Parameter, SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
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, int, int) - Static method in class org.orekit.forces.gravity.EarthGravitationalModelFactory
Create an instance of the gravitational field of a celestial body using Droziner model.
getDsph() - Method in class org.apache.commons.math3.analysis.polynomials.HelmholtzPolynomial
Get the H''lm coefficients
getDuration() - Method in class org.orekit.attitudes.AbstractSlew
 
getDuration() - Method in class org.orekit.utils.AbsoluteDateInterval
Computes the interval duration (its length) in seconds.
The duration is the number of seconds physically elapsed between the lower and the upper endpoint, as computed by AbsoluteDate.durationFrom().
This means the duration is measured in a linear time scale (TAI time scale).
getDurations() - Method in class org.orekit.attitudes.TabulatedAttitude
Getter for durations.
getDX() - Method in class org.orekit.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 org.orekit.frames.configuration.eop.NutationCorrection
Get the δX2000 parameter (radians).
getDY() - Method in class org.orekit.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 org.orekit.frames.configuration.eop.NutationCorrection
Get the δY2000 parameter (radians).
getE() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
 
getE() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant e.
getE() - Method in class org.orekit.orbits.ApsisOrbit
Get the eccentricity.
getE() - Method in class org.orekit.orbits.CartesianOrbit
Get the eccentricity.
getE() - Method in class org.orekit.orbits.CircularOrbit
Get the eccentricity.
getE() - Method in class org.orekit.orbits.EquatorialOrbit
Get the eccentricity.
getE() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the eccentricity.
getE() - Method in class org.orekit.orbits.KeplerianOrbit
Get the eccentricity.
getE() - Method in class org.orekit.orbits.Orbit
Get the eccentricity.
getE() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Get the eccentricity.
getE() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Get the eccentricity.
getE() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the eccentricity.
getE() - Method in class org.orekit.propagation.SpacecraftState
Get the eccentricity.
getEarliest() - Method in class org.orekit.utils.TimeStampedCache
Get the earliest cached entry.
getEarth() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Earth singleton body.
getEarthMoonBarycenter() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Earth-Moon barycenter singleton bodies pair.
getEarthRadius() - Method in class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Get the earth radius.
getEarthRotationAngle(AbsoluteDate) - Static method in class org.orekit.frames.transformations.TIRFProvider
Get the Earth Rotation Angle at the current date.
getEarthRotationRate(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.stela.bodies.EarthRotation
Deprecated. 
getEarthRotationRate() - Static method in class org.orekit.frames.transformations.TIRFProvider
Get the Earth Rotation rate.
getEarthShape() - Method in class org.orekit.propagation.events.LatitudeDetector
Returns the Earth shape.
getEarthShape() - Method in class org.orekit.propagation.events.NadirSolarIncidenceDetector
Returns Earth shape.
getEast() - Method in class org.orekit.bodies.GeodeticPoint
Get the direction to the east of point, expressed in parent shape frame.
getEast() - Method in class org.orekit.frames.TopocentricFrame
Get the east direction of topocentric frame, expressed in parent shape frame.
getEccentricAnomaly() - Method in class org.orekit.orbits.EquatorialOrbit
Get the eccentric anomaly.
getEccentricAnomaly() - Method in class org.orekit.orbits.KeplerianOrbit
Get the eccentric anomaly.
getEccentricAnomaly() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Get the eccentric anomaly.
getEccentricAnomaly() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Get the eccentric anomaly.
getEccentricity() - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Get the eccentricity.
getEccentricity() - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
 
getEclipseDetector() - Method in class fr.cnes.sirius.patrius.events.CentralBodyMaskCircularFOVDetector
Get the eclipse detector.
getEdges() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getEffects() - Method in class org.orekit.propagation.analytical.AdapterPropagator
Get the differential effects.
getEigenvector(int) - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets a copy of the ith eigenvector of the original matrix.
getElement() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
Get the contained element.
getElement(int) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the element at the specified index
getElement(int) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the element at the specified index
getElement(int) - Method in interface org.apache.commons.math3.util.DoubleArray
Returns the element at the specified index.
getElement(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns the element at the specified index
getElementNumber() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the element number.
getElements() - Method in interface org.apache.commons.math3.util.DoubleArray
Returns a double[] array containing the elements of this DoubleArray.
getElements() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns a double array containing the elements of this ResizableArray.
getElevation(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the elevation of a point with regards to the local point.
getElevation() - Method in class org.orekit.propagation.events.ApparentElevationDetector
Get the threshold apparent elevation value.
getElevation() - Method in class org.orekit.propagation.events.ElevationDetector
Get the threshold elevation value.
getElevation(double) - Method in class org.orekit.propagation.events.GroundMaskElevationDetector
Get the interpolated elevation for a given azimuth according to the mask.
getElevation() - Method in class org.orekit.utils.TopocentricPosition
Get the elevation angle.
getElevation() - Method in class org.orekit.utils.TopocentricPV
Get the elevation angle.
getElevationRate(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the elevation rate of a point.
getElevationRate() - Method in class org.orekit.utils.TopocentricPV
Get the elevation rate.
getElitismRate() - Method in class org.apache.commons.math3.genetics.ElitisticListPopulation
Access the elitism rate.
getEllipsoidicCoordinates(Vector3D) - Method in class org.apache.commons.math3.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 org.orekit.forces.gravity.tides.ITerrestrialTidesDataProvider
Get second degree Love number for the ellipticity perturbation.
getEllipticityCorrectionLoveNumber2() - Method in class org.orekit.forces.gravity.tides.TerrestrialTidesDataProvider
 
getEllipticityFactor() - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
 
getEm() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getEME2000() - Static method in class org.orekit.frames.FramesFactory
Get the unique EME2000 frame.
getEmissivity(AbsoluteDate, double, double) - Method in interface org.orekit.forces.radiation.IEmissivityModel
Get the albedo and infrared emissivities.
getEmissivity(AbsoluteDate, double, double) - Method in class org.orekit.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)
getEmpiricalDistribution() - Method in class org.apache.commons.math3.random.ValueServer
Returns the EmpiricalDistribution used when operating in 0.
getEnd() - Method in class org.apache.commons.math3.geometry.euclidean.threed.LineSegment
 
getEnd() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Segment
Get the end point of the segment.
getEnd() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
Get the end point of the segment.
getEndDate() - Method in class fr.cnes.sirius.patrius.signalpropagation.SignalPropagation
 
getEndDate() - Method in class org.orekit.forces.maneuvers.ConstantThrustError
Return the maneuver stop date (if a date or a DateDetector as been provided).
getEndDate() - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Return the maneuver stop date (if a date or a DateDetector as been provided).
getEndDate() - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Return the maneuver stop date (if a date or a DateDetector as been provided).
getEndDate() - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Get the date of the last available Earth Orientation Parameters.
getEndDate() - Method in class org.orekit.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
 
getEndDate() - Method in interface org.orekit.frames.configuration.eop.EOPHistory
Get the date of the last available Earth Orientation Parameters.
getEndDate() - Method in class org.orekit.frames.configuration.eop.NoEOP2000History
getEndDate.
getEndingEvent() - Method in class fr.cnes.sirius.patrius.events.Phenomenon
Get the ending event.
getEndingIsDefined() - Method in class fr.cnes.sirius.patrius.events.Phenomenon
True if the second boundary value is defined.
getEntries() - Method in class org.orekit.utils.TimeStampedCache
Get the total number of entries cached.
getEntry(int, int) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Returns the value of one entry of the matrix
getEntry(int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Get the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Returns the entry in the specified index.
getEntry(int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Return the entry at the specified index.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Get the entry in the specified row and column.
getEntry(int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the entry in the specified row and column.
getEntry(int) - Method in interface org.apache.commons.math3.linear.FieldVector
Returns the entry in the specified index.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Get the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Return the entry at the specified index.
getEntry(int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math3.linear.RealVector
Return the entry at the specified index.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Returns the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Returns the entry in the specified index.
getEntry(int, int) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Get the entry in the specified row and column.
getEODFrame(boolean) - Static method in class org.orekit.frames.FramesFactory
This class implements the EOD frame (mean ecliptic and equinox of the epoch).
getEOP1980History() - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Get Earth Orientation Parameters history (IAU1980) data.
getEOP1980History(EOPInterpolators) - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Get Earth Orientation Parameters history (IAU1980) data.
getEOP2000History() - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Get Earth Orientation Parameters history (IAU2000) data.
getEOP2000History(EOPInterpolators) - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Get Earth Orientation Parameters history (IAU2000) data.
getEOP2000History(EOPInterpolators, EOP2000HistoryLoader) - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Get Earth Orientation Parameters history (IAU2000) data using a specific loader.
getEOP2000History() - Method in interface org.orekit.frames.configuration.FramesConfiguration
Get the EOP history.
getEOP2000History() - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Get the EOP history.
getEOP2000HistoryConstant() - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Get Earth Orientation Parameters history (IAU2000) data.
getEOP2000HistoryConstant(EOPInterpolators) - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Get Earth Orientation Parameters history (IAU2000) data.
getEOP2000HistoryConstant(EOPInterpolators, EOP2000HistoryLoader) - Static method in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Get Earth Orientation Parameters history (IAU2000) data using a specific loader.
getEOPInterpolationMethod() - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Return the EOP interpolation method.
getEOPInterpolationMethod() - Method in interface org.orekit.frames.configuration.eop.EOPHistory
Return the EOP interpolation method.
getEOPInterpolationMethod() - Method in class org.orekit.frames.configuration.eop.NoEOP2000History
EOPInterpolators.
getEOPInterpolationMethod() - Method in interface org.orekit.frames.configuration.FramesConfiguration
Return the EOP interpolation method.
getEOPInterpolationMethod() - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Get the EOP interpolation method.
getEp() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getEphemeris(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiEphemerisModeHandler
Get the generated ephemeris of the given spacecraft Id.
getEphemeris() - Method in class fr.cnes.sirius.patrius.tools.force.validation.PVEphemerisLoader
Give the list of PV coordinates which have been read.
getEphemeris() - Method in interface fr.cnes.sirius.validate.mocks.ephemeris.IUserEphemeris
 
getEphemeris() - Method in class fr.cnes.sirius.validate.mocks.ephemeris.UserEphemeris
 
getEphemeris() - Method in class org.orekit.attitudes.TwoSpinBiasSlew
Get the attitude ephemeris representing the slew
getEphemeris() - Method in class org.orekit.propagation.analytical.AnalyticalEphemerisModeHandler
Get the generated ephemeris.
getEphemerisType() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the type of ephemeris.
getEpoch() - Method in interface org.orekit.files.general.OrbitFile
Returns the start epoch of the orbit file.
getEpoch() - Method in class org.orekit.files.general.SatelliteTimeCoordinate
Returns the epoch for this coordinate.
getEpoch() - Method in class org.orekit.files.sp3.SP3File
Returns the start epoch of the orbit file.
getEpoch() - Method in class org.orekit.frames.transformations.HelmertTransformation
Get the reference epoch of the transform.
getEpoch() - Method in class org.orekit.models.earth.GeoMagneticField
Returns the epoch for this magnetic field model.
getEpoch() - Method in class org.orekit.time.AbsoluteDate
Returns the epoch attribute.
May be used, with a matching offset value, to rebuild an AbsoluteDate with the AbsoluteDate.AbsoluteDate(long, double) constructor.
getEpochInterval() - Method in interface org.orekit.files.general.OrbitFile
Returns the time interval between epochs (in seconds).
getEpochInterval() - Method in class org.orekit.files.sp3.SP3File
Returns the time interval between epochs (in seconds).
getEps() - Method in class org.apache.commons.math3.stat.clustering.DBSCANClusterer
Returns the maximum radius of the neighborhood to be considered.
getEquationOfEquinoxes(AbsoluteDate) - Static method in class org.orekit.frames.transformations.TODProvider
Get the Equation of the Equinoxes at the current date.
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 org.orekit.orbits.EquatorialOrbit
Getter for underlying equatorial parameters.
getEquatorialParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters(double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters() - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialParameters() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Convert current orbital parameters into equatorial parameters.
getEquatorialRadius() - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
Get the equatorial radius of the body.
getEquatorialRadius() - Method in class org.orekit.bodies.OneAxisEllipsoid
Get the equatorial radius of the body.
getEquinoctialEx() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Get the first component of the eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.orbits.ApsisOrbit
Get the first component of the eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.orbits.CartesianOrbit
Get the first component of the eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.orbits.CircularOrbit
Get the first component of the equinoctial eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.orbits.EquatorialOrbit
Get the first component of the eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the first component of the eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.orbits.KeplerianOrbit
Get the first component of the eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.orbits.Orbit
Get the first component of the equinoctial eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Get the first component of the eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Get the first component of the eccentricity vector.
getEquinoctialEx() - Method in class org.orekit.propagation.SpacecraftState
Get the first 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.
getEquinoctialEy() - Method in class org.orekit.orbits.ApsisOrbit
Get the second component of the eccentricity vector.
getEquinoctialEy() - Method in class org.orekit.orbits.CartesianOrbit
Get the second component of the eccentricity vector.
getEquinoctialEy() - Method in class org.orekit.orbits.CircularOrbit
Get the second component of the equinoctial eccentricity vector.
getEquinoctialEy() - Method in class org.orekit.orbits.EquatorialOrbit
Get the second component of the eccentricity vector.
getEquinoctialEy() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the second component of the eccentricity vector.
getEquinoctialEy() - Method in class org.orekit.orbits.KeplerianOrbit
Get the second component of the eccentricity vector.
getEquinoctialEy() - Method in class org.orekit.orbits.Orbit
Get the second component of the equinoctial eccentricity vector.
getEquinoctialEy() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Get the second component of the eccentricity vector.
getEquinoctialEy() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Get the second component of the eccentricity vector.
getEquinoctialEy() - Method in class org.orekit.propagation.SpacecraftState
Get the second component of the eccentricity vector (as per equinoctial parameters).
getEquinoctialParameters() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Getter for underlying equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.EquinoctialOrbit
Getter for underlying equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters(double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters() - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Convert current orbital parameters into equinoctial parameters.
getEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Convert current orbital parameters into equinoctial parameters.
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.
getErrorCovariance() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns the current error covariance matrix.
getErrorCovarianceMatrix() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns a copy of the current error covariance matrix.
getErrorSumSquares() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the sum of squared errors (SSE) associated with the regression model.
getESplit() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant e split in two pieces.
getEulerAngles(AbsoluteDate) - Method in class org.orekit.frames.transformations.MODProvider
Compute Euler angles (3, 2, 3) of MOD => EME2000 transformation and their derivatives with respect to time.
getEvaluations() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the number of function evaluations of the last run of the integrator.
getEvaluations() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the number of function evaluations of the last run of the integrator.
getEvaluations() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the number of evaluations of the objective function.
getEvaluations() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - Method in class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Gets the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getEvaluations() - Method in class org.apache.commons.math3.optim.univariate.MultiStartUnivariateOptimizer
Gets the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated. Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated. Get the number of evaluations of the objective function.
getEvaluations() - Method in interface org.apache.commons.math3.optimization.BaseOptimizer
Deprecated. Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated. Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.  
getEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated. Get the number of evaluations of the objective function.
getEvent() - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Get event to detect.
getEventDetector() - Method in class fr.cnes.sirius.patrius.events.multi.MultiEventsLogger.MultiLoggedEvent
Get the event detector triggered.
getEventDetector() - Method in class org.orekit.propagation.events.EventsLogger.LoggedEvent
Get the event detector triggered.
getEventDetector() - Method in class org.orekit.propagation.events.EventState
Get the underlying event detector.
getEventHandler() - Method in class org.apache.commons.math3.ode.events.EventState
Get the underlying event handler.
getEventHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get all the event handlers that have been added to the integrator.
getEventHandlers() - Method in interface org.apache.commons.math3.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.CodedEventsList
Finds one/more events in the list of CodedEvent following some criteria.
When a comment and a date are available, the method looks for a specific event in the list, otherwise if only the code is given as input, it looks for a list of events with the same code.
getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.EmpiricalForce
 
getEventsDetectors() - Method in class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
Get the discrete events related to the model.
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
 
getEventsDetectors() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Get all the events detectors that have been added.
getEventsDetectors() - Method in class org.orekit.forces.drag.DragForce
There are no discrete events for this model.
getEventsDetectors() - Method in interface org.orekit.forces.ForceModel
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.gravity.BalminoAttractionModel
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.gravity.CunninghamAttractionModel
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.gravity.DrozinerAttractionModel
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.gravity.NewtonianAttraction
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.gravity.ThirdBodyAttraction
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.gravity.tides.AbstractTides
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.maneuvers.ConstantThrustError
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
 
getEventsDetectors() - Method in class org.orekit.forces.radiation.RediffusedRadiationPressure
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.radiation.SolarRadiationPressure
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.relativistic.CoriolisRelativisticEffect
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.relativistic.LenseThirringRelativisticEffect
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.forces.relativistic.SchwarzschildRelativisticEffect
Get the discrete events related to the model.
getEventsDetectors() - Method in class org.orekit.propagation.AbstractPropagator
Get all the events detectors that have been added.
getEventsDetectors() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get all the events detectors that have been added.
getEventsDetectors() - Method in interface org.orekit.propagation.Propagator
Get all the events detectors that have been added.
getEventTime() - Method in class org.apache.commons.math3.ode.events.EventState
Get the occurrence time of the event triggered in the current step.
getEventTime() - Method in class org.orekit.propagation.events.EventState
Get the occurrence time of the event triggered in the current step.
getEventType() - Method in interface fr.cnes.sirius.patrius.events.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.GenericCodingEventDetector
 
getEventType() - Method in interface fr.cnes.sirius.patrius.events.multi.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.multi.MultiGenericCodingEventDetector
 
getException() - Method in exception org.orekit.errors.OrekitExceptionWrapper
Get the wrapped exception.
getExModel() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Get the x eccentricity component parameter model.
getExosphericTemp() - Method in class org.orekit.forces.atmospheres.JB2006
Get the exospheric temperature above input position.
getExpansionFactor() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Return type will be changed to "double" in 4.0.
getExpansionMode() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Return value to be changed to ResizableDoubleArray.ExpansionMode in 4.0.
getExpectedColumnDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
 
getExpectedDimension(int) - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
 
getExpectedDimensions() - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
 
getExpectedRowDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
 
getExponent() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Return the exponent of the instance value, removing the bias.
getExponent() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Get the exponent characterizing the distribution.
getExponent(double) - Static method in class org.apache.commons.math3.util.FastMath
Return the exponent of a double number, removing the bias.
getExponent(float) - Static method in class org.apache.commons.math3.util.FastMath
Return the exponent of a float number, removing the bias.
getEyModel() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Get the y eccentricity component parameter model.
getF() - Method in class org.orekit.data.BodiesElements
Get L - Ω where L is the mean longitude of the Moon.
getF() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Getter for flattening.
getF10(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.JB2006InputParameters
Get the value of the instantaneous solar flux index (1e-22*Watt/(m2*Hertz)).
getF107() - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Getter for f107.
getF107A() - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Getter for f107A.
getF10B(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.JB2006InputParameters
Get the value of the mean solar flux.
getFaces() - Method in class org.apache.commons.math3.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.
getFactoryKey() - Method in class org.orekit.frames.FactoryManagedFrame
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 org.apache.commons.math3.exception.NoBracketingException
Get the value at the higher end of the interval.
getFHi() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
Get function value at BracketFinder.getHi().
getFHi() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated. Get function value at BracketFinder.getHi().
getField() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.complex.Complex
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.dfp.Dfp
Get the Field (really a DfpField) to which the instance belongs.
getField() - Method in interface org.apache.commons.math3.FieldElement
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.fraction.BigFraction
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.fraction.Fraction
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the type of field elements of the matrix.
getField() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Get the type of field elements of the vector.
getField() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the type of field elements of the matrix.
getField() - Method in interface org.apache.commons.math3.linear.FieldVector
Get the type of field elements of the vector.
getField() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Get the type of field elements of the vector.
getField() - Method in class org.apache.commons.math3.util.BigReal
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math3.util.Decimal64
Get the Field to which the instance belongs.
getField(GeoMagneticFieldFactory.FieldModel, AbsoluteDate) - Static method in class org.orekit.models.earth.GeoMagneticFieldFactory
Get the GeoMagneticField for the given model type and year.
getField(GeoMagneticFieldFactory.FieldModel, double) - Static method in class org.orekit.models.earth.GeoMagneticFieldFactory
Get the GeoMagneticField for the given model type and year.
getFieldVector() - Method in class org.orekit.models.earth.GeoMagneticElements
Returns the magnetic field vector in the topocentric frame (North=X, East=Y, Nadir=Z) in nTesla.
getFileDate(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Get the date of the file from which data at the specified date comes from.
getFilter(int) - Static method in enum org.orekit.utils.AngularDerivativesFilter
Get the filter corresponding to a maximum derivation order.
getFilter(int) - Static method in enum org.orekit.utils.CartesianDerivativesFilter
Get the filter corresponding to a maximum derivation order.
getFinalTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the final integration time.
getFirst() - Method in class org.apache.commons.math3.genetics.ChromosomePair
Access the first chromosome.
getFirst() - Method in class org.apache.commons.math3.util.Pair
Get the first element of the pair.
getFirst() - Method in class org.orekit.propagation.analytical.tle.TLESeries
Get the first TLE.
getFirstAttitudeLeg() - Method in class org.orekit.attitudes.AttitudeLegsSequence
Gets the first leg.
getFirstBody() - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Get 1st body
getFirstBody() - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
Get 1st body.
getFirstCovarianceMatrix() - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
 
getFirstDate() - Method in class org.orekit.propagation.analytical.tle.TLESeries
Get the start date of the series.
getFirstFileColumnIndexes() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
get the column indexes of the first file
getFirstFileColumnTypes() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
get the column indexes of the first file
getFirstFileType() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
get the type of the first file.
getFirstIndex() - Method in class org.apache.commons.math3.ode.EquationsMapper
Get the index of the first equation element in complete state arrays.
getFirstKnownLeapSecond() - Method in class org.orekit.time.UTCScale
Get the date of the first known leap second.
getFirstRefusedLines() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ThresholdsData
computes the line number of the first margins column by column.
getFitness() - Method in class org.apache.commons.math3.genetics.Chromosome
Access the fitness of this chromosome.
getFittedParameters() - Method in class org.orekit.utils.SecularAndHarmonic
Get a copy of the last fitted parameters.
getFittestChromosome() - Method in class org.apache.commons.math3.genetics.ListPopulation
Access the fittest chromosome in this population.
getFittestChromosome() - Method in interface org.apache.commons.math3.genetics.Population
Access the fittest chromosome in this population.
getFixedDateType() - Method in class fr.cnes.sirius.patrius.signalpropagation.SignalPropagation
 
getFlagAlbedo() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
 
getFlagAlbedo() - Method in interface org.orekit.forces.radiation.RediffusedRadiationSensitive
albedo getter
getFlagIr() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
 
getFlagIr() - Method in interface org.orekit.forces.radiation.RediffusedRadiationSensitive
infrared setter
getFlattening() - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
Return the flattening
getFLo() - Method in exception org.apache.commons.math3.exception.NoBracketingException
Get the value at the lower end of the interval.
getFLo() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
Get function value at BracketFinder.getLo().
getFLo() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated. Get function value at BracketFinder.getLo().
getFlowRate(SpacecraftState) - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Get the flow rate.
getFlux() - Method in class org.orekit.forces.radiation.RediffusedFlux
getFlux : return all elementary rediffused fluxes
getFluxMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get maximum date of flux values
getFluxMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get maximum date of flux values
getFluxMaxDate() - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get maximum date of flux values
getFluxMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get maximum date of flux values
getFluxMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get minimum date of flux values
getFluxMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get minimum date of flux values
getFluxMinDate() - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get minimum date of flux values
getFluxMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get minimum date of flux values
getFMid() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
Get function value at BracketFinder.getMid().
getFMid() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated. Get function value at BracketFinder.getMid().
getForce() - Method in class org.orekit.wrenches.Wrench
 
getForceModels(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Get perturbing force models list.
getForceModels() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Get perturbing force models list.
getForceModels() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get perturbing force models list.
getForcesStepHandler() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Getter for forces step handler.
getFormat() - Method in class org.apache.commons.math3.geometry.VectorFormat
Get the components format.
getFormat() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the components format.
getFormat() - Method in class org.apache.commons.math3.linear.RealVectorFormat
Get the components format.
getFourier() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeriesApproximation
 
getFOV() - Method in class fr.cnes.sirius.patrius.events.EarthZoneDetector
Get FOV list
getFOV() - Method in class fr.cnes.sirius.patrius.groundstation.GeometricStationAntenna
 
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.Part
 
getFrame() - Method in class fr.cnes.sirius.patrius.events.EarthZoneDetector
Get the frame.
getFrame() - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
Returns ground station topocentric frame.
getFrame(String) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Get the frame in which the orbit is propagated.
getFrame(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
 
getFrame() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Get the frame in which the orbit is propagated.
getFrame() - Method in class org.orekit.attitudes.directions.ConstantVectorDirection
 
getFrame() - Method in class org.orekit.bodies.AbstractCelestialBody
Deprecated. 
getFrame() - Method in interface org.orekit.bodies.CelestialBody
Deprecated. as of 6.0 replaced by CelestialBody.getInertiallyOrientedFrame()
getFrame() - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Get the frame of the acceleration direction.
getFrame() - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Get the frame of the velocity increment.
getFrame() - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Get the frame of the acceleration direction.
getFrame(Predefined) - Static method in class org.orekit.frames.FramesFactory
Get one of the predefined frames.
getFrame() - Method in class org.orekit.orbits.Orbit
Get the frame in which the orbital parameters are defined.
getFrame() - Method in class org.orekit.propagation.AbstractPropagator
Get the frame in which the orbit is propagated.
getFrame() - Method in class org.orekit.propagation.analytical.tle.TLEPropagator
Get the frame in which the orbit is propagated.
getFrame() - Method in class org.orekit.propagation.AnalyticalIntegratedEphemeris
Get the frame in which the orbit is propagated.
getFrame() - Method in class org.orekit.propagation.events.NodeDetector
Get the frame in which the equator is defined.
getFrame() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get the frame in which the orbit is propagated.
getFrame() - Method in interface org.orekit.propagation.Propagator
Get the frame in which the orbit is propagated.
getFrame() - Method in class org.orekit.propagation.SpacecraftState
Get the inertial frame.
getFrame() - Method in class org.orekit.utils.AbstractBoundedPVProvider
Get the reference frame
getFreeParameters() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the number of free parameters.
getFreeParameters() - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the number of free parameters.
getFrequency() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
 
getFrequencyCorrection() - Method in interface org.orekit.forces.gravity.tides.ITerrestrialTidesDataProvider
Get the frequency corrections as a table of Love number corrections associated to a Doodson number i.e.
getFrequencyCorrection() - Method in class org.orekit.forces.gravity.tides.TerrestrialTidesDataProvider
 
getFrobeniusNorm() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the Frobenius norm of the matrix.
getFrobeniusNorm() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the Frobenius norm of the matrix.
getFrobeniusNorm() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the Frobenius norm of the matrix.
getFrozenFrame(Frame, AbsoluteDate, String) - Method in class org.orekit.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 org.apache.commons.math3.analysis.polynomials.FourierSeriesApproximation
 
getFunction() - Method in class org.apache.commons.math3.optim.linear.LinearOptimizer
 
getFunction() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated.  
getFunctionValueAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the function value accuracy of the solver.
getFunctionValueAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the function value accuracy of the solver.
getFunctionValueAccuracy() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Get the function accuracy.
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 org.orekit.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 org.orekit.frames.FramesFactory
Get the unique GCRF frame.
getGenerateCalls() - Method in class org.orekit.utils.TimeStampedCache
Get the number of calls to the generate method.
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
 
getGeneratedEphemeris() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Get the ephemeris generated during propagation.
getGeneratedEphemeris() - Method in class org.orekit.propagation.AbstractPropagator
Get the ephemeris generated during propagation.
getGeneratedEphemeris() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get the ephemeris generated during propagation.
getGeneratedEphemeris() - Method in interface org.orekit.propagation.Propagator
Get the ephemeris generated during propagation.
getGenerationsEvolved() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the number of generations evolved to reach StoppingCondition in the last run.
getGenerator() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Get the underlying normalized components generator.
getGenerator() - Method in class org.apache.commons.math3.random.UniformlyCorrelatedRandomVectorGenerator
Get the underlying normalized components generator.
getGenerator() - Method in class org.orekit.utils.TimeStampedCache
Get the generator.
getGeneratorUpperBounds() - Method in class org.apache.commons.math3.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.
getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured geometric mean implementation
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the geometric mean of all the aggregated data.
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the geometric mean of the available values
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getGeometricMean() - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the geometric mean of the values that have been added.
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getGeometricMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the geometric mean of the values that have been added.
getGeometricMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured geometric mean implementation.
getgLat() - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Getter for gLat.
getGlobalCurrentTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the current global grid point time.
getGlobalPreviousTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the previous global grid point time.
getgLong() - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Getter for gLong.
getGM() - Method in interface fr.cnes.sirius.validate.mocks.ephemeris.IEphemerisBody
 
getGM() - Method in class org.orekit.bodies.AbstractCelestialBody
Get the attraction coefficient of the body.
getGM() - Method in interface org.orekit.bodies.CelestialBody
Get the attraction coefficient of the body.
getGMST(AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.stela.bodies.EarthRotation
Compute Greenwich Mean Sideral Time.
getGMST(AbsoluteDate) - Static method in class org.orekit.frames.transformations.GTODProvider
Get the Greenwich mean sidereal time, in radians.
getGMST() - Static method in class org.orekit.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.
getGoalType() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateOptimizer
 
getGoalType() - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
 
getGoalType() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.  
getGoalType() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated.  
getGoalType() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.  
getGPS() - Static method in class org.orekit.time.TimeScalesFactory
Get the Global Positioning System scale.
getGpsWeek() - Method in class org.orekit.files.sp3.SP3File
Returns the GPS week as contained in the SP3 file.
getGravitationalModel(EarthGravitationalModelFactory.GravityFieldNames, int, int) - Static method in class org.orekit.forces.gravity.EarthGravitationalModelFactory
Create an default instance of a gravitational field of a celestial body using Balmino model.
getGroundLoss() - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
 
getGroundPointingLaw() - Method in class org.orekit.attitudes.GroundPointingWrapper
Deprecated. as of 6.0, replaced by GroundPointingWrapper.getUnderlyingAttitudeLaw()
getGST() - Static method in class org.orekit.time.TimeScalesFactory
Get the Galileo System Time scale.
getGTOD(boolean) - Static method in class org.orekit.frames.FramesFactory
Get the GTOD reference frame.
getH() - Method in class org.apache.commons.math3.linear.QRDecomposition
Returns the Householder reflector vectors.
getH0MinusN(String, AbsoluteDate, double, double) - Static method in class org.orekit.frames.FramesFactory
Get the "H0 - n" reference frame.
getH0MinusN(String, AbsoluteDate, double) - Static method in class org.orekit.frames.FramesFactory
Get the "H0 - n" reference frame.
getHalfAperture() - Method in class org.orekit.propagation.events.CircularFieldOfViewDetector
Get fov half aperture angle.
getHalfAperture1() - Method in class org.orekit.propagation.events.DihedralFieldOfViewDetector
Get the half aperture angle of fov 1st dihedra.
getHalfAperture2() - Method in class org.orekit.propagation.events.DihedralFieldOfViewDetector
Get the half aperture angle of fov 2nd dihedra.
getHarmonicAmplitude() - Method in class org.orekit.utils.SecularAndHarmonic
Get an upper bound of the fitted harmonic amplitude.
getHeight() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
 
getHeight() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
 
getHeight() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
 
getHeight() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
 
getHi() - Method in exception org.apache.commons.math3.exception.NoBracketingException
Get the higher end of the interval.
getHi() - Method in exception org.apache.commons.math3.exception.OutOfRangeException
 
getHi() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getHi() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.  
getHorizontalIntensity() - Method in class org.orekit.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 org.orekit.time.TimeComponents
Get the hour number.
getHx() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
 
getHx() - Method in class org.orekit.orbits.ApsisOrbit
Get the first component of the inclination vector.
getHx() - Method in class org.orekit.orbits.CartesianOrbit
Get the first component of the inclination vector.
getHx() - Method in class org.orekit.orbits.CircularOrbit
Get the first component of the inclination vector.
getHx() - Method in class org.orekit.orbits.EquatorialOrbit
Get hx = ix / (2 * cos(i/2)), where ix is the first component of the inclination vector.
getHx() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the first component of the inclination vector.
getHx() - Method in class org.orekit.orbits.KeplerianOrbit
Get the first component of the inclination vector.
getHx() - Method in class org.orekit.orbits.Orbit
Get the first component of the inclination vector.
getHx() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Get the first component of the inclination vector.
getHx() - Method in class org.orekit.propagation.SpacecraftState
Get the first component of the inclination vector (as per equinoctial parameters).
getHy() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
 
getHy() - Method in class org.orekit.orbits.ApsisOrbit
Get the second component of the inclination vector.
getHy() - Method in class org.orekit.orbits.CartesianOrbit
Get the second component of the inclination vector.
getHy() - Method in class org.orekit.orbits.CircularOrbit
Get the second component of the inclination vector.
getHy() - Method in class org.orekit.orbits.EquatorialOrbit
Get hy = iy / (2 * cos(i/2)), where iy is the second component of the inclination vector.
getHy() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the second component of the inclination vector.
getHy() - Method in class org.orekit.orbits.KeplerianOrbit
Get the second component of the inclination vector.
getHy() - Method in class org.orekit.orbits.Orbit
Get the second component of the inclination vector.
getHy() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Get the second component of the inclination vector.
getHy() - Method in class org.orekit.propagation.SpacecraftState
Get the second component of the inclination vector (as per equinoctial parameters).
getHyperplane() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Get the underlying hyperplane.
getHyperplane() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Get the underlying hyperplane.
getI() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
 
getI() - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
 
getI() - Method in class org.orekit.orbits.ApsisOrbit
Get the inclination.
getI() - Method in class org.orekit.orbits.CartesianOrbit
Get the inclination.
getI() - Method in class org.orekit.orbits.CircularOrbit
Get the inclination.
getI() - Method in class org.orekit.orbits.EquatorialOrbit
Get the inclination angle.
getI() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the inclination.
getI() - Method in class org.orekit.orbits.KeplerianOrbit
Get the inclination.
getI() - Method in class org.orekit.orbits.Orbit
Get the inclination.
getI() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Get the inclination.
getI() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Get the inclination.
getI() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Get the inclination.
getI() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Get the inclination.
getI() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the inclination.
getI() - Method in class org.orekit.propagation.SpacecraftState
Get the inclination.
getIAUPole() - Method in interface fr.cnes.sirius.validate.mocks.ephemeris.IEphemerisBody
 
getIAUPole(JPLEphemeridesLoader.EphemerisType) - Static method in class org.orekit.bodies.IAUPoleFactory
Get an IAU pole.
getICRF() - Static method in class org.orekit.frames.FramesFactory
Get the unique ICRF frame.
getID() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.OneSatEventDetectorWrapper
Returns the ID of the spacecraft associated with the detector.
getId() - Method in class fr.cnes.sirius.validate.parallel.AbstractSimpleParallelTaskImpl
 
getIdList() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
Get the list of spacecraft ID.
getIEEEFlags() - Method in class org.apache.commons.math3.dfp.DfpField
Get the IEEE 854 status flags.
getIERS2003Configuration(boolean) - Static method in class org.orekit.frames.configuration.FramesConfigurationFactory
Gets the default IERS2003 configuration (always the same instance, not a new one).
getIERS2010Configuration() - Static method in class org.orekit.frames.configuration.FramesConfigurationFactory
Gets the default IERS2010 configuration (always the same instance, not a new one).
getIGRF(AbsoluteDate) - Static method in class org.orekit.models.earth.GeoMagneticFieldFactory
Get the IGRF model for the given year.
getIGRF(double) - Static method in class org.orekit.models.earth.GeoMagneticFieldFactory
Get the IGRF model for the given year.
getImagEigenvalue(int) - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets the imaginary part of the ith eigenvalue of the original matrix.
getImagEigenvalues() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets a copy of the imaginary parts of the eigenvalues of the original matrix.
getImaginary() - Method in class org.apache.commons.math3.complex.Complex
Access the imaginary part.
getImaginary(int) - Method in class org.apache.commons.math3.complex.RootsOfUnity
Get the imaginary part of the k-th n-th root of unity.
getImaginaryCharacter() - Method in class org.apache.commons.math3.complex.ComplexFormat
Access the imaginaryCharacter.
getImaginaryFormat() - Method in class org.apache.commons.math3.complex.ComplexFormat
Access the imaginaryFormat.
getImproperInstance() - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Returns the default complex format for the current locale.
getImproperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Returns the default complex format for the given locale.
getImproperInstance() - Static method in class org.apache.commons.math3.fraction.FractionFormat
Returns the default complex format for the current locale.
getImproperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.FractionFormat
Returns the default complex format for the given locale.
getIncidence() - Method in class org.orekit.propagation.events.NadirSolarIncidenceDetector
Returns incidence.
getInclination() - Method in class org.orekit.models.earth.GeoMagneticElements
Returns the inclination of the magnetic field in degrees.
getInclusiveInterval() - Method in class org.orekit.utils.AbsoluteDateIntervalsList
Gets the shortest interval containing all the intervals belonging to the list.
While a date included in at least one of the listed intervals must be contained in this global interval, the opposite is not guaranteed (the inclusive interval can contain dates that do not belong to any listed interval).
getIncModel() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Get the inclination parameter model.
getIncreasingTimeShift() - Method in class org.orekit.propagation.events.EventShifter
Get the increasing events time shift.
getIndex() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
Get the index of the wrong value.
getIndex() - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapEntry
Deprecated. Get the index of the entry.
getIndex() - Method in class org.apache.commons.math3.linear.RealVector.Entry
Get the index of the entry.
getIndex(double) - Method in class org.apache.commons.math3.utils.BinarySearchIndexClosedOpen
Returns the index of x in a tab with a dichotomy / BinarySearch algorithm under the convention ISearchIndex.SearchIndexIntervalConvention.CLOSED_OPEN.
getIndex(double, int, int) - Method in class org.apache.commons.math3.utils.BinarySearchIndexClosedOpen
Returns the index of x in a tab with a dichotomy / BinarySearch algorithm under the convention ISearchIndex.SearchIndexIntervalConvention.CLOSED_OPEN.
getIndex(double) - Method in class org.apache.commons.math3.utils.BinarySearchIndexOpenClosed
Returns the index of x in a tab with a dichotomy / BinarySearch algorithm under the convention ISearchIndex.SearchIndexIntervalConvention.OPEN_CLOSED.
getIndex(double, int, int) - Method in class org.apache.commons.math3.utils.BinarySearchIndexOpenClosed
Returns the index of x in a tab with a dichotomy / BinarySearch algorithm under the convention ISearchIndex.SearchIndexIntervalConvention.OPEN_CLOSED.
getIndex(double) - Method in interface org.apache.commons.math3.utils.ISearchIndex
Returns the index of x in a tab depending on the convention used.
getIndex(double, int, int) - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.utils.RecordSegmentSearchIndex
Returns the index of x in a tab depending on the convention used.
getIndex(double, int, int) - Method in class org.apache.commons.math3.utils.RecordSegmentSearchIndex
Returns the index of x in the extracted tab [tab[iMin], tab[iMax]] depending on the convention used.
getIndex() - Method in class org.orekit.propagation.numerical.AdditionalStateInfo
Get the index of the additional state in the state vector.
getIndexClosedOpen(double) - Method in class org.apache.commons.math3.utils.RecordSegmentSearchIndex
Returns the index of x in a tab depending on the convention used.
getIndexInterval(AbsoluteDate) - Method in class org.orekit.propagation.analytical.twod.AbstractDateIntervalFunction
Returns index such as dateIntervals[k] <= date <= dateIntervals[k+1].
getIndexOpenClosed(double) - Method in class org.apache.commons.math3.utils.RecordSegmentSearchIndex
Returns the index of x in a tab depending on the convention used.
getInertialDV() - Method in class org.orekit.forces.maneuvers.SmallManeuverAnalyticalModel
Get the inertial velocity increment of the maneuver.
getInertialFrame() - Method in class org.orekit.forces.maneuvers.SmallManeuverAnalyticalModel
Get the inertial frame in which the velocity increment is defined.
getInertiallyOrientedFrame() - Method in class org.orekit.bodies.AbstractCelestialBody
Get an inertially oriented, body centered frame.
getInertiallyOrientedFrame() - Method in interface org.orekit.bodies.CelestialBody
Get an inertially oriented, body centered frame.
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 org.apache.commons.math3.geometry.euclidean.oned.Interval
Get the lower bound of the interval.
getInf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Get the lowest value belonging to the instance.
getInfraRedPressure() - Method in class org.orekit.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.sensor.SensorInhibitionDetector
Get the inhibition number.
getInhibitionNumber() - Method in class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
Get the inhibition number.
getInhibitionTargetAngularRadius(AbsoluteDate, int) - 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 org.apache.commons.math3.filter.DefaultProcessModel
Returns the initial error covariance matrix.
getInitialErrorCovariance() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the initial error covariance matrix.
getInitialGuess() - Method in class org.apache.commons.math3.optim.InitialGuess
Gets the initial guess.
getInitialGuess() - Method in class org.apache.commons.math3.optimization.InitialGuess
Deprecated. Gets the initial guess.
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.stela.propagation.StelaAbstractPropagator
Get the propagator initial state.
getInitialState() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
 
getInitialState() - Method in class org.orekit.propagation.AbstractPropagator
Get the propagator initial state.
getInitialState() - Method in class org.orekit.propagation.analytical.AdapterPropagator
Get the propagator initial state.
getInitialState() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get the propagator initial state.
getInitialState() - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
Get the propagator initial state.
getInitialState() - Method in class org.orekit.propagation.precomputed.Ephemeris
Get the propagator initial state.
getInitialState() - Method in class org.orekit.propagation.precomputed.IntegratedEphemeris
Get the propagator initial state.
getInitialState() - Method in interface org.orekit.propagation.Propagator
Get the propagator initial state.
getInitialStateEstimate() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
Returns the initial state estimation vector.
getInitialStateEstimate() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the initial state estimation vector.
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
 
getInitialTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the initial integration time.
getInMainSpacecraftId() - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
Get the main spacecraft id.
getInSecondarySpacecraftId() - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
Get the secondary spacecraft id.
getInSightAxis() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
 
getInSpacecraftId1() - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Get the first spacecraft id
getInSpacecraftId1() - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
Get the first spacecraft id.
getInSpacecraftId2() - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Get the second spacecraft id
getInSpacecraftId2() - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
Get the second spacecraft id.
getInSpacecraftId3() - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Get the third spacecraft id
getInSpacecraftId3() - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
Get the third spacecraft id.
getInstance() - Static method in class org.apache.commons.math3.complex.ComplexField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.complex.ComplexFormat
Returns the default complex format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.complex.ComplexFormat
Returns the default complex format for the given locale.
getInstance(String, Locale) - Static method in class org.apache.commons.math3.complex.ComplexFormat
Returns the default complex format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.fraction.BigFractionField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.fraction.FractionField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Returns the default 1D vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Returns the default 1D vector format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Returns the default 3D vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Returns the default 3D vector format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Returns the default 2D vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Returns the default 2D vector format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.linear.RealMatrixFormat
Returns the default real vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.linear.RealMatrixFormat
Returns the default real vector format for the given locale.
getInstance() - Static method in class org.apache.commons.math3.linear.RealVectorFormat
Returns the default real vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math3.linear.RealVectorFormat
Returns the default real vector format for the given locale.
getInstance(int) - Static method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Get the Nordsieck transformer for a given number of steps.
getInstance() - Static method in class org.apache.commons.math3.ode.sampling.DummyStepHandler
Get the only instance.
getInstance() - Static method in class org.apache.commons.math3.util.BigRealField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math3.util.Decimal64Field
Returns the unique instance of this class.
getInstance() - Static method in class org.orekit.data.DataProvidersManager
Get the unique instance.
getInstantFlux(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.DTM2000InputParameters
Get the value of the instantaneous solar flux.
getInstantFlux(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.MSISE2000InputParameters
Get the value of the instantaneous solar flux.
getInstantFlux(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get the value of the instantaneous solar flux.
getInstantFlux(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Get the value of the instantaneous solar flux.
getInstantFlux(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.ContinuousMSISE2000SolarData
Get the value of the instantaneous solar flux.
getInstantFlux(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.DTM2000SolarData
Get the value of the instantaneous solar flux.
getInstantFlux(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Get the value of the instantaneous solar flux.
getInstantFluxValue(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get instant flux values at the given dates (possibly interpolated)
getInstantFluxValue(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get instant flux values at the given dates (possibly interpolated)
getInstantFluxValue(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get instant flux values at the given dates (possibly interpolated)
getInstantFluxValue(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get instant flux values at the given dates (possibly interpolated)
getInstantFluxValues(AbsoluteDate, AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get raw instant flux values between the given dates
getInstantFluxValues(AbsoluteDate, AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get raw instant flux values between the given dates
getInstantFluxValues(AbsoluteDate, AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get raw instant flux values between the given dates
getInstantFluxValues(AbsoluteDate, AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get raw instant flux values between the given dates
getIntegrator() - Method in class org.orekit.attitudes.kinematics.AbstractVector3DFunction
Get the integrator.
getIntercept() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the intercept of the estimated regression line, if SimpleRegression.hasIntercept() is true; otherwise 0.
getInterceptStdErr() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the standard error of the intercept estimate, usually denoted s(b0).
getInternalValues() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1.
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.MultiOrekitStepInterpolator
Get the interpolated date.
getInterpolatedDate() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
Get the interpolated date.
getInterpolatedDate() - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Get the interpolated date.
getInterpolatedDate() - Method in class org.orekit.propagation.sampling.BasicStepInterpolator
Get the interpolated date.
getInterpolatedDate() - Method in interface org.orekit.propagation.sampling.OrekitStepInterpolator
Get the interpolated date.
getInterpolatedDerivatives() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the derivatives of the state vector of the interpolated point.
getInterpolatedDerivatives() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the derivatives of the state vector of the interpolated point.
getInterpolatedSecondaryDerivatives(int) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the interpolated secondary derivatives corresponding to the secondary equations.
getInterpolatedSecondaryDerivatives(int) - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the interpolated secondary derivatives corresponding to the secondary equations.
getInterpolatedSecondaryState(int) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the interpolated secondary state corresponding to the secondary equations.
getInterpolatedSecondaryState(int) - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the interpolated secondary state corresponding to the secondary equations.
getInterpolatedSpacecraftState(AbsoluteDate) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
Get the interpolated spacecraft state.
getInterpolatedSpacecraftState(AbsoluteDate) - Method in class org.orekit.propagation.precomputed.HermiteEphemeris
Deprecated. Get the interpolated spacecraft state.
getInterpolatedSpacecraftState(AbsoluteDate) - Method in class org.orekit.propagation.precomputed.LagrangeEphemeris
Deprecated. Get the interpolated spacecraft state.
getInterpolatedState() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
Get the interpolated state.
getInterpolatedState() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the state vector of the interpolated point.
getInterpolatedState() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the state vector of the interpolated point.
getInterpolatedState() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the state vector of the interpolated point.
getInterpolatedState() - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Get the interpolated state.
getInterpolatedState() - Method in class org.orekit.propagation.sampling.BasicStepInterpolator
Get the interpolated state.
getInterpolatedState() - Method in interface org.orekit.propagation.sampling.OrekitStepInterpolator
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.MultiOrekitStepInterpolator
Get all the interpolated states.
getInterpolatedStateVariation() - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Get the state vector variation from current to interpolated state.
getInterpolatedTime() - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Get the time of the interpolated point.
getInterpolatedTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the time of the interpolated point.
getInterpolatedTime() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the time of the interpolated point.
getInterpolatingPoints() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating points array.
getInterpolatingTabValues() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating values matrix.
getInterpolatingValues() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating values array.
getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate) - Method in interface org.orekit.bodies.BodyShape
Get the intersection point of a line with the surface of the body.
getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
 
getIntersectionPoint(Line, Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.bodies.OneAxisEllipsoid
Get the intersection point of a line with the surface of the body.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This methods computes and returns the intersection points between a line and the cone.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
This methods computes and returns the intersection points between a line and the cylinder.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCone
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Compute the intersection points with another line if it exists.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in interface org.apache.commons.math3.geometry.euclidean.threed.Shape
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Compute the intersection points with a line.
getIntersectionPoints(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCap
Returns a list of intersection points between the line and the spherical cap.
Only the border points are given.
getIntersectionPoints(Line, Frame, AbsoluteDate) - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
 
getIntersectionPoints(Line, Frame, AbsoluteDate) - Method in interface org.orekit.bodies.GeometricBodyShape
Compute the intersection points with a line.
getIntersectionWith(AbsoluteDateInterval) - Method in class org.orekit.utils.AbsoluteDateInterval
Intersects the interval with another interval if possible (i.e.
getIntervalOfValidity() - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
 
getIntervalsContainingDate(AbsoluteDate) - Method in class org.orekit.utils.AbsoluteDateIntervalsList
Gets the AbsoluteDateIntervalsList containing the specified date.
getInverse() - Method in class org.apache.commons.math3.complex.Quaternion
Returns the inverse of this instance.
getInverse() - Method in interface org.apache.commons.math3.linear.DecompositionSolver
Get the inverse (or pseudo-inverse) of the decomposed matrix.
getInverse() - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
Get the inverse (or pseudo-inverse) of the decomposed matrix.
getInverse(boolean) - Method in class org.orekit.frames.transformations.Transform
Get the inverse transform of the instance.
getInverse() - Method in class org.orekit.frames.transformations.Transform
Get the inverse transform of the instance.
getInverseConditionNumber() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Computes the inverse of the condition number.
getISP() - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Get the specific impulse.
getIsp() - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Get the specific impulse.
getISP(SpacecraftState) - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Get the specific impulse.
getIterationManager() - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
Returns the iteration manager attached to this solver.
getIterations() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the number of iterations of the last run of the integrator.
getIterations() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the number of iterations of the last run of the integrator.
getIterations() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the number of iterations performed by the algorithm.
getIterations() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated. Get the number of iterations realized by the algorithm.
getIterations() - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
Deprecated. Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math3.util.IterationEvent
Returns the number of iterations performed at the time this event is created.
getIterations() - Method in class org.apache.commons.math3.util.IterationManager
Returns the number of iterations of this solver, 0 if no iterations has been performed yet.
getITRF() - Static method in class org.orekit.frames.FramesFactory
Get the ITRF reference frame.
getITRFEquinox() - Static method in class org.orekit.frames.FramesFactory
Get the equinox-based ITRF reference frame.
getIx() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Get the first component of the inclination vector.
getIx() - Method in class org.orekit.orbits.EquatorialOrbit
Get the first component of the inclination vector.
getIx() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Get the first component of the inclination vector.
getIx() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Get the first component of the inclination vector.
getIy() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Get the second component of the inclination vector.
getIy() - Method in class org.orekit.orbits.EquatorialOrbit
Get the second component of the inclination vector.
getIy() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Get the second component of the inclination vector.
getIy() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Get the second component of the inclination vector.
getJ(boolean, int) - Method in interface org.orekit.forces.gravity.potential.PotentialCoefficientsProvider
Get the zonal coefficients.
getJ(boolean, int) - Method in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Get the zonal coefficients.
getJ2000Day() - Method in class org.orekit.time.DateComponents
Get the day number with respect to J2000 epoch.
getJacobian(Orbit, PositionAngle, double[][]) - Method in class org.orekit.forces.maneuvers.SmallManeuverAnalyticalModel
Compute the Jacobian of the orbit with respect to maneuver parameters.
getJacobian(double[][]) - Method in class org.orekit.frames.transformations.Transform
Compute the Jacobian of the Transform.transformPVCoordinates(PVCoordinates) method of the transform.
getJacobian(OrbitType, OrbitType) - Method in class org.orekit.orbits.Orbit
Get coordinate conversion jacobian.
getJacobianEvaluations() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated.  
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
 
getJacobianParameters() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
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.
getJacobianParameters() - Method in interface org.orekit.propagation.numerical.JacobianParametersProvider
Get the list of all jacobian parameters supported.
getJacobianWrtCartesian(PositionAngle, double[][]) - Method in class org.orekit.orbits.Orbit
Compute the Jacobian of the orbital parameters with respect to the Cartesian parameters.
getJacobianWrtParameters(PositionAngle, double[][]) - Method in class org.orekit.orbits.EquinoctialOrbit
Compute the Jacobian of the Cartesian parameters with respect to the orbital parameters.
getJacobianWrtParameters(PositionAngle, double[][]) - Method in class org.orekit.orbits.Orbit
Compute the Jacobian of the Cartesian parameters with respect to the orbital parameters.
getJacobianWrtParametersEccentric() - Method in class org.orekit.orbits.Orbit
 
getJacobianWrtParametersMean() - Method in class org.orekit.orbits.Orbit
 
getJacobianWrtParametersTrue() - Method in class org.orekit.orbits.Orbit
 
getJQNUMProperty() - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
getJQNUMProperty "rule"
getJQNUMProperty(String) - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
getJQNUMProperty
getJulianDay() - Method in class org.orekit.files.sp3.SP3File
Returns the julian day for this SP3 file.
getJupiter() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Jupiter singleton body.
getK() - Method in class org.apache.commons.math3.util.Combinations
Gets the number of elements in each combination.
getKeplerianMeanMotion() - Method in class org.orekit.orbits.Orbit
Get the keplerian mean motion.
getKeplerianMeanMotion() - Method in class org.orekit.propagation.SpacecraftState
Get the keplerian mean motion.
getKeplerianParameters() - Method in class org.orekit.orbits.KeplerianOrbit
Getter for underlying keplerian parameters.
getKeplerianParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianParameters() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianParameters(double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into circular parameters.
getKeplerianParameters() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianParameters() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianParameters() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianParameters() - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianParameters() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianParameters() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianParameters() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Convert current orbital parameters into Keplerian parameters.
getKeplerianPeriod() - Method in class org.orekit.orbits.Orbit
Get the keplerian period.
getKeplerianPeriod() - Method in class org.orekit.propagation.SpacecraftState
Get the keplerian period.
getKeplerianTransitionMatrix(double) - Method in class org.orekit.orbits.Orbit
Get keplerian transition matrix.
getKey() - Method in class org.apache.commons.math3.util.Pair
Get the key.
getKeys() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets all the keys stored in the exception
getKnots() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get an array copy of the knot points.
getKp(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get Kp value at given user date
getKp(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get Kp value at given user date
getKp(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get Kp value at given user date
getKp(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get Kp value at given user date
getKurtosis() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the Kurtosis of the available values.
getKurtosisImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured kurtosis implementation.
getL() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
Returns the matrix L of the decomposition.
getL() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Returns the matrix L of the decomposition.
getL() - Method in class org.apache.commons.math3.linear.LUDecomposition
Returns the matrix L of the decomposition.
getL() - Method in class org.orekit.data.BodiesElements
Get the mean anomaly of the Moon.
getL(PositionAngle) - Method in class org.orekit.orbits.EquinoctialOrbit
Get the longitude argument.
getL(PositionAngle) - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Get the longitude argument.
getL1Distance(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Distance between two vectors.
getL1Distance(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Distance between two vectors.
getL1Distance(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Distance between two vectors.
getL1Distance(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Distance between two vectors.
getL1Norm() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns the L1 norm of the vector.
getL1Norm() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Get the node whose element is the largest one in the tree.
getLast() - Method in class org.orekit.propagation.analytical.tle.TLESeries
Get the last TLE.
getLastAttitudeLeg() - Method in class org.orekit.attitudes.AttitudeLegsSequence
Gets the last leg.
getLastDate() - Method in class org.orekit.propagation.analytical.tle.TLESeries
Get the last date of the series.
getLastKnownLeapSecond() - Method in class org.orekit.time.UTCScale
Get the date of the last known leap second.
getLatest() - Method in class org.orekit.utils.TimeStampedCache
Get the latest cached entry.
getLatitude() - Method in class org.orekit.bodies.GeodeticPoint
Get the latitude.
getLatitude() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Getter for latitude.
getLatitudeToDetect() - Method in class org.orekit.propagation.events.LatitudeDetector
Returns the latitude to detect.
getLaunchNumber() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the launch number.
getLaunchPiece() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the launch piece.
getLaunchYear() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the launch year.
getLbModel() - Method in class fr.cnes.sirius.patrius.events.sensor.RFVisibilityDetector
Get the RF link budget model.
getLbThreshold() - Method in class fr.cnes.sirius.patrius.events.sensor.RFVisibilityDetector
Get the RF link budget threshold.
getLE() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Get the eccentric latitude argument.
getLE() - Method in class org.orekit.data.BodiesElements
Get the mean Earth longitude.
getLE() - Method in class org.orekit.orbits.ApsisOrbit
Get the eccentric latitude argument.
getLE() - Method in class org.orekit.orbits.CartesianOrbit
Get the eccentric latitude argument.
getLE() - Method in class org.orekit.orbits.CircularOrbit
Get the eccentric latitude argument.
getLE() - Method in class org.orekit.orbits.EquatorialOrbit
Get the eccentric latitude argument.
getLE() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the eccentric longitude argument.
getLE() - Method in class org.orekit.orbits.KeplerianOrbit
Get the eccentric latitude argument.
getLE() - Method in class org.orekit.orbits.Orbit
Get the eccentric latitude argument.
getLE() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Get the eccentric longitude argument.
getLE() - Method in class org.orekit.propagation.SpacecraftState
Get the eccentric latitude argument (as per equinoctial parameters).
getLeap(AbsoluteDate) - Method in class org.orekit.time.UTCScale
Get the value of the previous leap.
getLength() - Method in class fr.cnes.sirius.patrius.utils.AngleInterval
 
getLength() - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
Returns the length of the chromosome.
getLength() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Deprecated. as of 3.1, replaced by Interval.getSize()
getLength() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
 
getLength() - Method in class org.apache.commons.math3.geometry.euclidean.threed.LineSegment
 
getLength() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
 
getLength() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getLength() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
 
getLength() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
 
getLength() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
 
getLibrationCorrectionModel() - Method in class org.orekit.frames.configuration.DiurnalRotation
 
getLibrationCorrectionModel() - Method in class org.orekit.frames.configuration.PolarMotion
 
getLiftCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
Get the lift coefficient
getLightningRatio(PVCoordinatesProvider, GeometricBodyShape, Vector3D, Frame, AbsoluteDate) - Static method in class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
Get the lightning ratio ([0-1]).
getLightningRatio(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.forces.radiation.SolarRadiationPressure
Get the lightning ratio ([0-1]).
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(int) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Data
Gets a line.
getLine() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Segment
Get the line containing the segment.
getLine() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
Get the line containing the segment.
getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.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 org.orekit.attitudes.directions.ConstantVectorDirection
Provides the line containing the given origin point and directed by the direction vector
getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.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 org.orekit.attitudes.directions.EarthCenterDirection
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.GenericTargetDirection
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.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 org.orekit.attitudes.directions.GroundVelocityDirection
 
getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in interface org.orekit.attitudes.directions.IDirection
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.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 org.orekit.attitudes.directions.NadirDirection
 
getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.ToCelestialBodyCenterDirection
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
getLine(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.VelocityDirection
Provides the line containing the origin (given PV coordinates) and directed by the direction vector.
getLine1() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the first line.
getLine2() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the second line.
getLinearPolynomial() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get the Linear Polynomial Part
getLineNumber() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Data
gets the number of lines in the data table
getLineProperty() - Method in class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
Getter for line property .
getLineProperty() - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
Getter for line property .
getLineProperty() - Method in interface fr.cnes.sirius.patrius.projections.IProjection
Getter for line property .
getLineProperty() - Method in class fr.cnes.sirius.patrius.projections.Mercator
Getter for line property .
getLInfDistance(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Distance between two vectors.
getLInfDistance(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Distance between two vectors.
getLInfDistance(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Distance between two vectors.
getLInfNorm() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns the L norm of the vector.
getLInfNorm() - Method in class org.apache.commons.math3.linear.RealVector
Returns the L norm of the vector.
getList() - Method in class fr.cnes.sirius.patrius.events.CodedEventsList
Get the full list of coded events.
getList() - Method in class fr.cnes.sirius.patrius.events.PhenomenaList
Get the full list of Phenomenon.
getLJu() - Method in class org.orekit.data.BodiesElements
Get the mean Jupiter longitude.
getLM() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Get the mean longitude argument.
getLM() - Method in class org.orekit.orbits.ApsisOrbit
Get the mean latitude argument.
getLM() - Method in class org.orekit.orbits.CartesianOrbit
Get the mean latitude argument.
getLM() - Method in class org.orekit.orbits.CircularOrbit
Get the mean latitude argument.
getLM() - Method in class org.orekit.orbits.EquatorialOrbit
Get the mean latitude argument.
getLM() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the mean longitude argument.
getLM() - Method in class org.orekit.orbits.KeplerianOrbit
Get the mean latitude argument.
getLM() - Method in class org.orekit.orbits.Orbit
Get the mean latitude argument.
getLM() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Get the mean longitude argument.
getLM() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Get the mean longitude argument.
getLM() - Method in class org.orekit.propagation.SpacecraftState
Get the mean latitude argument (as per equinoctial parameters).
getLMa() - Method in class org.orekit.data.BodiesElements
Get the mean Mars longitude.
getLMe() - Method in class org.orekit.data.BodiesElements
Get the mean Mercury longitude.
getLn10() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(10).
getLn2() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(2).
getLn2Split() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(2) split in two pieces.
getLn5() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(5).
getLn5Split() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant ln(5) split in two pieces.
getLnaModel() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Get the longitude of ascending node parameter model.
getLNe() - Method in class org.orekit.data.BodiesElements
Get the mean Neptune longitude.
getLo() - Method in exception org.apache.commons.math3.exception.NoBracketingException
Get the lower end of the interval.
getLo() - Method in exception org.apache.commons.math3.exception.OutOfRangeException
 
getLo() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getLo() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.  
getLoadedAstronomicalUnit() - Method in class org.orekit.bodies.JPLEphemeridesLoader
Get astronomical unit.
getLoadedConstant(String...) - Method in class org.orekit.bodies.JPLEphemeridesLoader
Get a constant defined in the ephemerides headers.
getloadedData1() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
 
getloadedData2() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
 
getLoadedDataNames() - Method in class org.orekit.data.DataProvidersManager
Get an unmodifiable view of the set of data file names that have been loaded.
getLoadedEarthMoonMassRatio() - Method in class org.orekit.bodies.JPLEphemeridesLoader
Get Earth/Moon mass ratio.
getLoadedGravitationalCoefficient(JPLEphemeridesLoader.EphemerisType) - Method in class org.orekit.bodies.JPLEphemeridesLoader
Get the gravitational coefficient of a body.
getLocalBasisTransform() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Get transformation matrix (from standard basis to ellipsoid local basis)
getLocalBasisTransform() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns the matrix of the transformation to the local basis
getLocalBasisTransform() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.exception.MathArithmeticException
getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalArgumentException
getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalStateException
getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathRuntimeException
getLocalizedMessage() - Method in exception org.apache.commons.math3.exception.MathUnsupportedOperationException
getLocalizedMessage() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the message in the default locale.
getLocalizedMessage() - Method in exception org.orekit.errors.OrekitException
getLocalizedString(Locale) - Method in enum fr.cnes.sirius.patrius.exception.util.PatriusMessages
Gets the localized string.
getLocalizedString(Locale) - Method in enum fr.cnes.sirius.patrius.tools.exception.util.ToolsMessages
Gets the localized string.
getLocalizedString(Locale) - Method in class org.apache.commons.math3.exception.util.DummyLocalizable
Gets the localized string.
getLocalizedString(Locale) - Method in interface org.apache.commons.math3.exception.util.Localizable
Gets the localized string.
getLocalizedString(Locale) - Method in enum org.apache.commons.math3.exception.util.LocalizedFormats
Gets the localized string.
getLocalizedString(Locale) - Method in enum org.orekit.errors.OrekitAddonsMessages
Gets the localized string.
getLocalizedString(Locale) - Method in enum org.orekit.errors.OrekitMessages
Gets the localized string.
getLocalTemp() - Method in class org.orekit.forces.atmospheres.JB2006
Get the temperature at input position.
getLocation() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Get the hyperplane location on the real line.
getLOD(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Get the LoD (Length of Day) value.
getLOD(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
Get the LoD (Length of Day) value.
getLOD() - Method in class org.orekit.frames.configuration.eop.EOPEntry
Get the LoD (Length of Day) value.
getLOD(AbsoluteDate) - Method in interface org.orekit.frames.configuration.eop.EOPHistory
Get the LoD (Length of Day) value.
getLOD(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.NoEOP2000History
getLOD.
getLODCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.IERS2003TidalCorrection
Get length of day correction.
getLODCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.IERS2010TidalCorrection
Get length of day correction.
getLODCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.NoTidalCorrection
Get length of day correction.
getLODCorrection() - Method in class org.orekit.frames.configuration.tides.TidalCorrection
Get the length of day correction.
getLODCorrection(AbsoluteDate) - Method in interface org.orekit.frames.configuration.tides.TidalCorrectionModel
Get length of day correction.
getLoggedCodedEventSet() - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger
Returns an unmodifiable view on the set of CodedEventsLogger.LoggedCodedEvent, sorted by date.
getLoggedCodedEventSet() - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger
Returns an unmodifiable view on the set of MultiCodedEventsLogger.MultiLoggedCodedEvent, sorted by date.
getLoggedEvents() - Method in class fr.cnes.sirius.patrius.events.multi.MultiEventsLogger
Get an immutable copy of the logged events.
getLoggedEvents() - Method in class org.orekit.propagation.events.EventsLogger
Get an immutable copy of the logged events.
getLongitude() - Method in class org.orekit.bodies.GeodeticPoint
Get the longitude.
getLongitude() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Getter for longitude.
getLongitudeToDetect() - Method in class org.orekit.propagation.events.LongitudeDetector
Returns longitude to detect.
getLoveNumbers() - Method in interface org.orekit.forces.gravity.tides.IOceanTidesDataProvider
Get love numbers.
getLoveNumbers() - Method in class org.orekit.forces.gravity.tides.OceanTidesDataProvider
 
getLower() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Deprecated. as of 3.1, replaced by Interval.getInf()
getLower() - Method in class org.apache.commons.math3.optim.SimpleBounds
Gets the lower bounds.
getLower() - Method in class org.apache.commons.math3.optimization.SimpleBounds
Deprecated. Gets the lower bounds.
getLowerAngle() - Method in class fr.cnes.sirius.patrius.utils.AngleInterval
 
getLowerBound() - Method in class org.apache.commons.math3.optim.BaseMultivariateOptimizer
 
getLowerBound() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.  
getLowerBound() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
Deprecated.  
getLowerCaseAbbreviation() - Method in enum org.orekit.time.Month
Get the lower case three letters abbreviation.
getLowerCaseName() - Method in enum org.orekit.time.Month
Get the lower case full name.
getLowerData() - Method in class fr.cnes.sirius.patrius.utils.GenericInterval
 
getLowerData() - Method in class org.orekit.utils.GenericInterval
 
getLowerEndPoint() - Method in class fr.cnes.sirius.patrius.utils.AbstractInterval
 
getLowerEndpoint() - Method in class org.orekit.utils.GenericInterval
 
getLPrime() - Method in class org.orekit.data.BodiesElements
Get the mean anomaly of the Sun.
getLSa() - Method in class org.orekit.data.BodiesElements
Get the mean Saturn longitude.
getLst() - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Getter for lst.
getLT() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
Returns the transpose of the matrix L of the decomposition.
getLUr() - Method in class org.orekit.data.BodiesElements
Get the mean Uranus longitude.
getLv() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Get the true latitude argument.
getLv() - Method in class org.orekit.orbits.ApsisOrbit
Get the true latitude argument.
getLv() - Method in class org.orekit.orbits.CartesianOrbit
Get the true latitude argument.
getLv() - Method in class org.orekit.orbits.CircularOrbit
Get the true latitude argument.
getLv() - Method in class org.orekit.orbits.EquatorialOrbit
Get the true latitude argument.
getLv() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the true longitude argument.
getLv() - Method in class org.orekit.orbits.KeplerianOrbit
Get the true latitude argument.
getLv() - Method in class org.orekit.orbits.Orbit
Get the true latitude argument.
getLv() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Get the true longitude argument.
getLv() - Method in class org.orekit.propagation.SpacecraftState
Get the true latitude argument (as per equinoctial parameters).
getLVe() - Method in class org.orekit.data.BodiesElements
Get the mean Venus longitude.
getM() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
Getter for m coefficient.
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
getMainField() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
 
getMainPart() - Method in class fr.cnes.sirius.patrius.assembly.Assembly
 
getMainSpacecraft() - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
Get the main assembly to consider.
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
 
getMam() - Method in class org.orekit.forces.atmospheres.DTM2000
Get the local mean atomic mass.
getMapper() - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Get a mapper between two-dimensional Jacobians and one-dimensional additional state.
getMars() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Mars singleton body.
getMaskingBodyName() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
 
getMaskingObjectName() - Method in class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Get the masking object.
getMaskingObjectName() - Method in class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
Get the masking object.
getMaskingPartName() - Method in class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Get the masking part.
getMaskingPartName() - Method in class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
Get the masking part.
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(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
 
getMass(String) - Method in interface org.orekit.propagation.MassProvider
Return the mass of the given part.
getMass(String) - Method in class org.orekit.propagation.SimpleMassModel
This model represents one part only.
getMass(String) - Method in class org.orekit.propagation.SpacecraftState
Get the mass of the given part.
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
 
getMassProperty() - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
getMassProperty() - Method in interface fr.cnes.sirius.patrius.assembly.properties.IInertiaProperty
 
getMatrix() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the 3X3 matrix corresponding to the instance
getMatrix() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the 3X3 rotation matrix corresponding to the instance.
getMax() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
 
getMax() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
 
getMax() - Method in exception org.apache.commons.math3.exception.MaxCountExceededException
 
getMax() - Method in exception org.apache.commons.math3.exception.NumberIsTooLargeException
 
getMax() - Method in class org.apache.commons.math3.optim.univariate.SearchInterval
Gets the upper bound.
getMax() - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
 
getMax() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.  
getMax() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the maximum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMax() - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getMax() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the maximum of the values that have been added.
getMax() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the maximum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMax() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the maximum of the values that have been added.
getMaxAlt() - Method in class org.orekit.forces.atmospheres.HarrisPriester
Get the maximal altitude for the model.
getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
getMaxCheckInterval() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
 
getMaxCheckInterval() - Method in class org.apache.commons.math3.ode.events.EventState
Get the maximal time interval between events handler checks.
getMaxCheckInterval() - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Get maximal time interval between switching function checks.
getMaxCheckInterval() - Method in class org.orekit.propagation.events.AbstractDetector
Get maximal time interval between switching function checks.
getMaxCheckInterval() - Method in interface org.orekit.propagation.events.EventDetector
Get maximal time interval between switching function checks.
getMaxCheckInterval() - Method in interface org.orekit.propagation.events.multi.MultiEventDetector
Get maximal time interval between switching function checks.
getMaxCheckInterval() - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Get maximal time interval between switching function checks.
getMaxChunksDuration() - Method in class org.orekit.bodies.JPLEphemeridesLoader
Get the maximal chunks duration.
getMaxDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
Get the last date of the range.
getMaxDate() - Method in interface org.orekit.forces.atmospheres.DTM2000InputParameters
Gets the available data range maximum date.
getMaxDate() - Method in interface org.orekit.forces.atmospheres.JB2006InputParameters
Gets the available data range maximum date.
getMaxDate() - Method in interface org.orekit.forces.atmospheres.MSISE2000InputParameters
Gets the available data range maximum date.
getMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get maximum date at which both flux and ap values are available
getMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get maximum date at which both flux and ap values are available
getMaxDate() - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get maximum date at which both flux and ap values are available
getMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get maximum date at which both flux and ap values are available
getMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Gets the available data range maximum date.
getMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.DTM2000SolarData
Gets the available data range maximum date.
getMaxDate() - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Gets the available data range maximum date.
getMaxDate() - Method in class org.orekit.propagation.AnalyticalIntegratedEphemeris
Get the last date of the range.
getMaxDate() - Method in interface org.orekit.propagation.BoundedPropagator
Get the last date of the range.
getMaxDate() - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
Get the last date of the range.
getMaxDate() - Method in class org.orekit.propagation.precomputed.Ephemeris
Get the last date of the range.
getMaxDate() - Method in class org.orekit.propagation.precomputed.IntegratedEphemeris
Get the last date of the range.
getMaxDate() - Method in class org.orekit.utils.AbstractBoundedPVProvider
Get the last date of the range.
getMaxDate() - Method in class org.orekit.utils.EphemerisPvHermite
For hermite interpolation, the last date is the date of the step before the last ephemeris point
getMaxDate() - Method in class org.orekit.utils.EphemerisPvLagrange
Return the higher date authorized to call getPVCoordinates.
getMaxDegree(double, int) - Method in interface org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
Get maximum degree for given wave and order
getMaxDegree(double, int) - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Get maximum degree for given wave and order
getMaxDegree(double, int) - Method in class org.orekit.forces.gravity.tides.OceanTidesDataProvider
 
getMaxDegree() - Method in interface org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
Get the max degree available
getMaxDegree() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Get the max degree available
getMaxDeviations() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ComparisonData
gets the max of all the columns in a list.
getMaxEval() - Method in class org.apache.commons.math3.optim.MaxEval
Gets the maximum number of evaluations.
getMaxEvals() - Method in class org.apache.commons.math3.analysis.polynomials.FourierDecompositionEngine
 
getMaxEvaluations() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the maximum number of function evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the maximum number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated. Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated. Get the maximal number of function evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math3.optimization.BaseOptimizer
Deprecated. Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated. Get the maximal number of function evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.  
getMaxEvaluations() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated. Get the maximal number of function evaluations.
getMaxGrowth() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Get the maximal growth factor for stepsize control.
getMaxGrowth() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the maximal growth factor for stepsize control.
getMaximalCount() - Method in class org.apache.commons.math3.util.Incrementor
Gets the upper limit of the counter.
getMaximalIterationCount() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the upper limit for the number of iterations.
getMaximalIterationCount() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the upper limit for the number of iterations.
getMaximalOrder() - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Get the maximal order.
getMaximalOrder() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Get the maximal order.
getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured maximum implementation.
getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.linear.RealVector
Get the index of the maximum entry.
getMaxIter() - Method in class org.apache.commons.math3.optim.MaxIter
Gets the maximum number of evaluations.
getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
getMaxIterationCount() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
 
getMaxIterationCount() - Method in class org.apache.commons.math3.ode.events.EventState
Get the upper limit in the iteration count for event localization.
getMaxIterationCount() - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Get maximal number of iterations in the event time search.
getMaxIterationCount() - Method in class org.orekit.propagation.events.AbstractDetector
Get maximal number of iterations in the event time search.
getMaxIterationCount() - Method in interface org.orekit.propagation.events.EventDetector
Get maximal number of iterations in the event time search.
getMaxIterationCount() - Method in interface org.orekit.propagation.events.multi.MultiEventDetector
Get maximal number of iterations in the event time search.
getMaxIterationCount() - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Get maximal number of iterations in the event time search.
getMaxIterations() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Gets the maximal number of iterations.
getMaxIterations() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated. Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
Deprecated. Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in class org.apache.commons.math3.util.IterationManager
Returns the maximum number of iterations.
getMaxOrder(double) - Method in interface org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
Get maximum order for given wave
getMaxOrder(double) - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Get maximum order for given wave
getMaxOrder(double) - Method in class org.orekit.forces.gravity.tides.OceanTidesDataProvider
 
getMaxOrder() - Method in enum org.orekit.utils.AngularDerivativesFilter
Get the maximum derivation order.
getMaxOrder() - Method in enum org.orekit.utils.CartesianDerivativesFilter
Get the maximum derivation order.
getMaxOrders() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Return the array with the highest trigonometric orders available.
getMaxSlots() - Method in class org.orekit.utils.TimeStampedCache
Get the maximum number of independent cached time slots.
getMaxSpan() - Method in class org.orekit.utils.TimeStampedCache
Get the maximum duration span in seconds of one slot.
getMaxStep() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the maximal step.
getMaxTrigonometricOrder() - Method in class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Return the highest trigonometric order.
getMaxValue() - Method in class org.apache.commons.math3.linear.RealVector
Get the value of the maximum entry.
getMaxX() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
 
getMaxY() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
 
getMean() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Access the mean.
getMean() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Access the mean.
getMean() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Get the mean for the distribution.
getMean() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMean() - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getMean() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the mean of the values that have been added.
getMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMean() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the mean of the values that have been added.
getMeanAnomaly() - Method in class org.orekit.orbits.EquatorialOrbit
Get the mean anomaly.
getMeanAnomaly() - Method in class org.orekit.orbits.KeplerianOrbit
Get the mean anomaly.
getMeanAnomaly() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Get the mean anomaly.
getMeanAnomaly() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Get the mean anomaly.
getMeanAnomaly() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the mean anomaly.
getMeanAnomalyInit() - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
 
getMeanAp(AbsoluteDate, AbsoluteDate, SolarActivityDataProvider) - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityToolbox
Compute mean flux between given dates (rectangular rule)
getMeanDeviations() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ComparisonData
gets the mean of all the columns in a list.
getMeanFlux(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.DTM2000InputParameters
Get the value of the mean solar flux.
getMeanFlux(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.MSISE2000InputParameters
Get the 81 day average of F10.7 flux.
getMeanFlux(AbsoluteDate, AbsoluteDate, SolarActivityDataProvider) - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityToolbox
Compute mean flux between given dates using trapezoidal rule
getMeanFlux(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Get the 81 day average of F10.7 flux.
getMeanFlux(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.ContinuousMSISE2000SolarData
Get the 81 day average of F10.7 flux.
getMeanFlux(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.DTM2000SolarData
Get the value of the mean solar flux.
getMeanFlux(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Get the value of the mean solar flux.
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured mean implementation.
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured mean implementation
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.
getMeanMotion() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the mean motion.
getMeanMotionFirstDerivative() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the mean motion first derivative.
getMeanMotionSecondDerivative() - Method in class org.orekit.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 org.apache.commons.math3.distribution.MultivariateNormalDistribution
Gets the mean vector.
getMeanSquareError() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the sum of squared errors divided by the degrees of freedom, usually abbreviated MSE.
getMeanSquareError() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of squared errors divided by the degrees of freedom, usually abbreviated MSE.
getMeasurementDimension() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns the dimension of the measurement vector.
getMeasurementMatrix() - Method in class org.apache.commons.math3.filter.DefaultMeasurementModel
Returns the measurement matrix.
getMeasurementMatrix() - Method in interface org.apache.commons.math3.filter.MeasurementModel
Returns the measurement matrix.
getMeasurementNoise() - Method in class org.apache.commons.math3.filter.DefaultMeasurementModel
Returns the measurement noise matrix.
getMeasurementNoise() - Method in interface org.apache.commons.math3.filter.MeasurementModel
Returns the measurement noise matrix.
getMedian() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Access the median.
getMercury() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Mercury singleton body.
getMeritFactor() - Method in class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
 
getMessage() - Method in exception org.apache.commons.math3.exception.MathArithmeticException
getMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalArgumentException
getMessage() - Method in exception org.apache.commons.math3.exception.MathIllegalStateException
getMessage() - Method in exception org.apache.commons.math3.exception.MathRuntimeException
getMessage() - Method in exception org.apache.commons.math3.exception.MathUnsupportedOperationException
getMessage() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the default message.
getMessage(Locale) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the message in a specified locale.
getMessage(Locale, String) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the message in a specified locale.
getMessage(Locale) - Method in exception org.orekit.errors.OrekitException
Gets the message in a specified locale.
getMessage() - Method in exception org.orekit.errors.OrekitException
getMid() - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
 
getMid() - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated.  
getMidPoint() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Deprecated. as of 3.1, replaced by Interval.getBarycenter()
getMin() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
 
getMin() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
 
getMin() - Method in exception org.apache.commons.math3.exception.NumberIsTooSmallException
 
getMin() - Method in class org.apache.commons.math3.optim.univariate.SearchInterval
Gets the lower bound.
getMin() - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
 
getMin() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.  
getMin() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the minimum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMin() - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getMin() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the minimum of the values that have been added.
getMin() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the minimum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMin() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the minimum of the values that have been added.
getMinAlt() - Method in class org.orekit.forces.atmospheres.HarrisPriester
Get the minimal altitude for the model.
getMinDate() - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
Get the first date of the range.
getMinDate() - Method in interface org.orekit.forces.atmospheres.DTM2000InputParameters
Gets the available data range minimum date.
getMinDate() - Method in interface org.orekit.forces.atmospheres.JB2006InputParameters
Gets the available data range minimum date.
getMinDate() - Method in interface org.orekit.forces.atmospheres.MSISE2000InputParameters
Gets the available data range minimum date.
getMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ConstantSolarActivity
Get minimum date at which both flux and ap values are available
getMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.ExtendedSolarActivityWrapper
Get minimum date at which both flux and ap values are available
getMinDate() - Method in interface org.orekit.forces.atmospheres.solarActivity.SolarActivityDataProvider
Get minimum date at which both flux and ap values are available
getMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get minimum date at which both flux and ap values are available
getMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Gets the available data range minimum date.
getMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.DTM2000SolarData
Gets the available data range minimum date.
getMinDate() - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Gets the available data range minimum date.
getMinDate() - Method in class org.orekit.propagation.AnalyticalIntegratedEphemeris
Get the first date of the range.
getMinDate() - Method in interface org.orekit.propagation.BoundedPropagator
Get the first date of the range.
getMinDate() - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
Get the first date of the range.
getMinDate() - Method in class org.orekit.propagation.precomputed.Ephemeris
Get the first date of the range.
getMinDate() - Method in class org.orekit.propagation.precomputed.IntegratedEphemeris
Get the first date of the range.
getMinDate() - Method in class org.orekit.utils.AbstractBoundedPVProvider
Get the first date of the range.
getMinDate() - Method in class org.orekit.utils.EphemerisPvHermite
For hermite interpolation, the min date is the first ephemeris date which is also the reference date
getMinDate() - Method in class org.orekit.utils.EphemerisPvLagrange
Return the lower date authorized to call getPVCoordinates.
getMinDegree(double, int) - Method in interface org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsProvider
Get min degree for given wave and order
getMinDegree(double, int) - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Get min degree for given wave and order
getMinDegree(double, int) - Method in class org.orekit.forces.gravity.tides.OceanTidesDataProvider
 
getMinimalIterationCount() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the min limit for the number of iterations.
getMinimalIterationCount() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the min limit for the number of iterations.
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured minimum implementation.
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured minimum implementation
getMinIndex() - Method in class org.apache.commons.math3.linear.RealVector
Get the index of the minimum entry.
getMinPts() - Method in class org.apache.commons.math3.stat.clustering.DBSCANClusterer
Returns the minimum number of points needed for a cluster.
getMinReduction() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Get the minimal reduction factor for stepsize control.
getMinReduction() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the minimal reduction factor for stepsize control.
getMinStep() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the minimal step.
getMinus() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the tree on the minus side of the cut hyperplane.
getMinus() - Method in class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Get the part of the sub-hyperplane on the minus side of the splitting hyperplane.
getMinute() - Method in class org.orekit.time.TimeComponents
Get the minute number.
getMinValue() - Method in class org.apache.commons.math3.linear.RealVector
Get the value of the minimum entry.
getMinX() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
 
getMinY() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
 
getMJD() - Method in class org.orekit.time.DateComponents
Get the modified julian day.
getMOD(boolean) - Static method in class org.orekit.frames.FramesFactory
Get the MOD reference frame.
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
 
getMode() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Get the current operating mode of the propagator.
getMode() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Returns the mode c of this distribution.
getMode() - Method in class org.apache.commons.math3.random.ValueServer
Returns the data generation mode.
getMode() - Method in class org.orekit.propagation.AbstractPropagator
Get the current operating mode of the propagator.
getMode() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get the current operating mode of the propagator.
getMode() - Method in interface org.orekit.propagation.Propagator
Get the current operating mode of the propagator.
getModelFunction() - Method in class org.apache.commons.math3.optim.nonlinear.vector.ModelFunction
Gets the model function to be optimized.
getModelFunctionJacobian() - Method in class org.apache.commons.math3.optim.nonlinear.vector.ModelFunctionJacobian
Gets the Jacobian of the model function to be optimized.
getModelName() - Method in class org.orekit.models.earth.GeoMagneticField
Returns the model name.
getModels() - Method in interface org.orekit.models.earth.GeoMagneticDataProvider
Returns a Collection of GeoMagneticField models.
getModels() - Method in class org.orekit.models.earth.GeoMagneticModelReader
Returns a Collection of the GeoMagneticField models that have been successfully loaded.
getModifiedRodrigues(double) - Method in class org.orekit.utils.AngularCoordinates
Convert rotation, rate and acceleration to modified Rodrigues vector and derivatives.
getModifiedRodrigues(double, boolean) - Method in class org.orekit.utils.AngularCoordinates
Convert rotation, rate and acceleration to modified Rodrigues vector and derivatives.
getMomentum() - Method in class org.orekit.utils.PVCoordinates
Gets the momentum.
getMonth() - Method in class org.orekit.time.DateComponents
Get the month.
getMonth(int) - Static method in enum org.orekit.time.Month
Get the month corresponding to a number.
getMonthEnum() - Method in class org.orekit.time.DateComponents
Get the month as an enumerate.
getMoon() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
Get the Moon.
getMoon() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Moon singleton body.
getMu(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Get the central attraction coefficient μ.
getMu() - Method in class org.apache.commons.math3.random.ValueServer
Returns the mean used when operating in ValueServer.GAUSSIAN_MODE, ValueServer.EXPONENTIAL_MODE or ValueServer.UNIFORM_MODE.
getMu() - Method in interface org.orekit.forces.gravity.AttractionModel
Get the central attraction coefficient &mu.
getMu() - Method in class org.orekit.forces.gravity.BalminoAttractionModel
Get the central attraction coefficient &mu.
getMu() - Method in class org.orekit.forces.gravity.CunninghamAttractionModel
Get the central attraction coefficient &mu.
getMu() - Method in class org.orekit.forces.gravity.DrozinerAttractionModel
Get the central attraction coefficient &mu.
getMu() - Method in class org.orekit.forces.gravity.NewtonianAttraction
Get the central attraction coefficient &mu.
getMu() - Method in interface org.orekit.forces.gravity.potential.PotentialCoefficientsProvider
Get the central body attraction coefficient.
getMu() - Method in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Get the central body attraction coefficient.
getMu() - Method in interface org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsProvider
Get the central body attraction coefficient.
getMu() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Get the central body attraction coefficient.
getMu() - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
 
getMu() - Method in class org.orekit.orbits.Orbit
Get the central acceleration constant.
getMu() - Method in class org.orekit.orbits.orbitalparameters.AbstractOrbitalParameters
Getter for the central acceleration constant.
getMu() - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Getter for the central acceleration constant.
getMu() - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
 
getMu() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Returns the standard gravitational parameter.
getMu() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get the central attraction coefficient μ.
getMu() - Method in class org.orekit.propagation.SpacecraftState
Get the central attraction coefficient.
getMultiDetector() - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger.MultiLoggedCodedEvent
Gets the MultiCodingEventDetector that generated the coded event.
getMutationPolicy() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the mutation policy.
getMutationRate() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the mutation rate.
getN() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
Getter for n coefficient.
getN() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get the number of spline segments.
getN() - Method in class org.apache.commons.math3.stat.correlation.Covariance
Returns the number of observations (length of covariate vectors)
getN() - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
This Covariance method is not supported by a StorelessCovariance, since the number of bivariate observations does not have to be the same for different pairs of covariates - i.e., N as defined in Covariance.getN() is undefined.
getN() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Get the number of vectors in the sample.
getN() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
Get the number of vectors in the sample.
getN() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Returns the number of values that have been added.
getN() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalMultivariateSummary
Returns the number of available values
getN() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getN() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Gets the number of observations added to the regression model.
getN() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the number of observations added to the regression model.
getN() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the number of observations that have been added to the model.
getN() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Returns the number of observations added to the regression model.
getN() - Method in class org.apache.commons.math3.util.Combinations
Gets the size of the set from which combinations are drawn.
getNadir() - Method in class org.orekit.bodies.GeodeticPoint
Get the direction below the point, expressed in parent shape frame.
getNadir() - Method in class org.orekit.frames.TopocentricFrame
Get the nadir direction of topocentric frame, expressed in parent shape frame.
getName() - Method in interface fr.cnes.sirius.patrius.assembly.IPart
 
getName() - Method in class fr.cnes.sirius.patrius.assembly.MainPart
 
getName() - Method in class fr.cnes.sirius.patrius.assembly.Part
 
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.events.sensor.SecondarySpacecraft
 
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 enum fr.cnes.sirius.patrius.projections.EnumLineProperty
Get the line property's name.
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
 
getName() - Method in enum org.apache.commons.math3.geometry.euclidean.twod.EnumPolygon
Getter for the enumerate name.
getName() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get the name of the method.
getName() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get the name of the method.
getName() - Method in exception org.apache.commons.math3.ode.UnknownParameterException
 
getName() - Method in class org.orekit.bodies.AbstractCelestialBody
Get the name of the body.
getName() - Method in interface org.orekit.bodies.CelestialBody
Get the name of the body.
getName() - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
 
getName() - Method in interface org.orekit.bodies.GeometricBodyShape
 
getName() - Method in class org.orekit.frames.Frame
Get the name.
getName() - Method in enum org.orekit.frames.Predefined
Get the name of the frame.
getName() - Method in class org.orekit.parameter.Parameter
Getting parameter name.
getName() - Method in interface org.orekit.propagation.AdditionalStateProvider
Get the name of the additional state.
getName() - Method in interface org.orekit.propagation.numerical.AdditionalEquations
Get the name of the additional state.
getName() - Method in class org.orekit.propagation.numerical.AttitudeEquation
Get the name of the additional equation.
getName() - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get the name of the partial Jacobians.
getName() - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Get the name of the additional state.
getName() - Method in class org.orekit.time.GalileoScale
Get the name time scale.
getName() - Method in class org.orekit.time.GMSTScale
Get the name time scale.
getName() - Method in class org.orekit.time.GPSScale
Get the name time scale.
getName() - Method in class org.orekit.time.TAIScale
Get the name time scale.
getName() - Method in class org.orekit.time.TCBScale
Get the name time scale.
getName() - Method in class org.orekit.time.TCGScale
Get the name time scale.
getName() - Method in class org.orekit.time.TDBScale
Get the name time scale.
getName() - Method in interface org.orekit.time.TimeScale
Get the name time scale.
getName() - Method in class org.orekit.time.TTScale
Get the name time scale.
getName() - Method in class org.orekit.time.UT1Scale
Get the name time scale.
getName() - Method in class org.orekit.time.UTCScale
Get the name time scale.
getNanStrategy() - Method in class org.apache.commons.math3.stat.ranking.NaturalRanking
Return the NaNStrategy
getNbPoints() - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Get the number of points to use.
getNeighbors(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Get the entries surrounding a central date.
getNeighbors(AbsoluteDate) - Method in class org.orekit.utils.TimeStampedCache
Get the entries surrounding a central date.
getNeighborsSize() - Method in class org.orekit.utils.TimeStampedCache
Get the fixed size of the arrays to be returned by TimeStampedCache.getNeighbors(AbsoluteDate).
getNeptune() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Neptune singleton body.
getNewOrphanFrame(String) - Static method in class org.orekit.frames.OrphanFrame
This method creates an Orphan Frame.
getNewSlotQuantumGap() - Method in class org.orekit.utils.TimeStampedCache
Get quantum gap above which a new slot is created instead of extending an existing one.
getNewtonCoefficients() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of coefficients in Newton form formula.
getNewtonianAttractionForceModel(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Get the Newtonian attraction from the central body force model.
getNewtonianAttractionForceModel() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get the Newtonian attraction from the central body force model.
getNext() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
Get the node containing the next larger or equal element.
getNext() - Method in class org.apache.commons.math3.random.ValueServer
Returns the next generated value, generated according to the mode value (see MODE constants).
getNextAttitudeLeg(AttitudeLeg) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Gets the next attitude law after the selected AttitudeLeg law.
getNextAttitudeLeg(String) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Gets the next attitude law after the AttitudeLeg law with the selected code.
getNextValue() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Generates a random value from this distribution.
getNonRotatingLaw() - Method in class org.orekit.attitudes.SpinStabilized
Deprecated. as of 6.0, replaced by SpinStabilized.getUnderlyingAttitudeLaw()
getNorm() - Method in class org.apache.commons.math3.complex.Quaternion
Computes the norm of the quaternion.
getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the L2 norm for the vector.
getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the L2 norm for the vector.
getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the L2 norm for the vector.
getNorm() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the L2 norm for the vector.
getNorm() - Method in interface org.apache.commons.math3.geometry.Vector
Get the L2 norm for the vector.
getNorm() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Returns the L2 norm of the vector.
getNorm() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in class org.apache.commons.math3.linear.RealVector
Returns the L2 norm of the vector.
getNorm() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the L2 norm of the matrix.
getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the L1 norm for the vector.
getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the L1 norm for the vector.
getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the L1 norm for the vector.
getNorm1() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the L1 norm for the vector.
getNorm1() - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
 
getNormal(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Computes the normal vector to the surface in local basis
getNormal(Vector3D) - Method in interface org.apache.commons.math3.geometry.euclidean.threed.IEllipsoid
Computes the normal vector to the surface in local basis
getNormal() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the normalized normal vector.
getNormal(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Computes the normal vector to the surface
getNormal(Vector3D) - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
Return the normal vector to the surface from the ellipsoid
getNormalCoef() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroFacetProperty
Get the normal force parametrizable function.
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 org.apache.commons.math3.transform.AbstractFastFourierTransformer
Gets the private attribute normalization.
getNormalizedCCoefs(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.OceanTides
Get normalized C coefficients table
getNormalizedSCoefs(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.OceanTides
Get normalized S coefficients table
getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the L norm for the vector.
getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the L norm for the vector.
getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the L norm for the vector.
getNormInf() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the L norm for the vector.
getNormInf() - Method in interface org.apache.commons.math3.geometry.Vector
Get the L norm for the vector.
getNormOfResidual() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns the norm of the residual.
getNormOfResidual() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns the norm of the residual.
getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the square of the norm for the vector.
getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the square of the norm for the vector.
getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the square of the norm for the vector.
getNormSq() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the square of the norm for the vector.
getNormSq() - Method in interface org.apache.commons.math3.geometry.Vector
Get the square of the norm for the vector.
getNorth() - Method in class org.orekit.bodies.GeodeticPoint
Get the direction to the north of point, expressed in parent shape frame.
getNorth() - Method in class org.orekit.frames.TopocentricFrame
Get the north direction of topocentric frame, expressed in parent shape frame.
getNotLarger(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Get the node whose element is not larger than the reference object.
getNotSmaller(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Get the node whose element is not smaller than the reference object.
getNSteps() - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Get the number of steps of the method (excluding the one being computed).
getNumber() - Method in enum org.orekit.time.Month
Get the month number.
getNumberOfAcceptable() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ThresholdsData
computes the number of acceptable margins column by column
getNumberOfColumns() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
get the number of columns that will be used in the ephemeris files.
getNumberOfElements() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Get the number of elements (e.g.
getNumberOfEpochs() - Method in interface org.orekit.files.general.OrbitFile
Returns the number of epochs contained in this orbit file.
getNumberOfEpochs() - Method in class org.orekit.files.sp3.SP3File
Returns the number of epochs contained in this orbit file.
getNumberOfParameters() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the number of parameters estimated in the model.
getNumberOfPoints() - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegrator
 
getNumberOfRefused() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ThresholdsData
computes the number of refused margins column by column
getNumberOfRoots() - Method in class org.apache.commons.math3.complex.RootsOfUnity
Returns the number of roots of unity currently stored.
getNumberOfSuccesses() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the number of successes.
getNumberOfSuccesses() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Access the number of successes for this distribution.
getNumberOfTrials() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Access the number of trials for this distribution.
getNumElements() - Method in interface org.apache.commons.math3.util.DoubleArray
Returns the number of elements currently in the array.
getNumElements() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns the number of elements currently in the array.
getNumerator() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the numerator as a BigInteger.
getNumerator() - Method in class org.apache.commons.math3.fraction.Fraction
Access the numerator.
getNumeratorAsInt() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the numerator as a int.
getNumeratorAsLong() - Method in class org.apache.commons.math3.fraction.BigFraction
Access the numerator as a long.
getNumeratorDegreesOfFreedom() - Method in class org.apache.commons.math3.distribution.FDistribution
Access the numerator degrees of freedom.
getNumeratorFormat() - Method in class org.apache.commons.math3.fraction.AbstractFormat
Access the numerator format.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.FDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.TDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalMean() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Use this method to get the numerical value of the mean of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.FDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.TDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumericalVariance() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Use this method to get the numerical value of the variance of this distribution.
getNumGenerations() - Method in class org.apache.commons.math3.genetics.FixedGenerationCount
Returns the number of generations that have already passed.
getNutationCoefficients() - Method in interface org.orekit.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 org.orekit.forces.gravity.tides.TerrestrialTidesDataProvider
 
getNutationCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Get the correction to the nutation parameters.
getNutationCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
Get the correction to the nutation parameters.
getNutationCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.NoEOP2000History
 
getObjectiveFunction() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.ObjectiveFunction
Gets the function to be optimized.
getObjectiveFunction() - Method in class org.apache.commons.math3.optim.univariate.UnivariateObjectiveFunction
Gets the function to be optimized.
getObjectiveFunction() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Gets the objective vector function.
getObjectiveFunctionGradient() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.ObjectiveFunctionGradient
Gets the gradient of the function to be optimized.
getObservations() - Method in class org.apache.commons.math3.fitting.CurveFitter
Get the observed points.
getObservations() - Method in class org.apache.commons.math3.optimization.fitting.CurveFitter
Deprecated. Get the observed points.
getOcculted() - Method in class org.orekit.propagation.events.EclipseDetector
Get the occulted body.
getOccultedDirection() - Method in class org.orekit.propagation.events.EclipseDetector
 
getOccultedRadius() - Method in class org.orekit.propagation.events.EclipseDetector
Get the occulted body radius (m).
getOcculting() - Method in class org.orekit.propagation.events.EclipseDetector
Get the occulting body.
getOccultingRadius(Vector3D, Frame, AbsoluteDate, PVCoordinatesProvider) - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
 
getOccultingRadius(Vector3D, Frame, AbsoluteDate, PVCoordinatesProvider) - Method in interface org.orekit.bodies.GeometricBodyShape
Calculate the apparent radius.
getOccurence() - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Get the occurrence to detect.
getOffset(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Get the offset (oriented distance) of a point.
getOffset(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the offset (oriented distance) of a parallel plane.
getOffset(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the offset (oriented distance) of a point.
getOffset(Line) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the offset (oriented distance) of a parallel line.
getOffset(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the offset (oriented distance) of a point.
getOffset(Vector<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Get the offset (oriented distance) of a point.
getOffset() - Method in class org.orekit.time.AbsoluteDate
Returns the offset attribute.
May be used, with a matching epoch value, to rebuild an AbsoluteDate with the AbsoluteDate.AbsoluteDate(long, double) constructor.
getOldAttitudeOnTransition(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Returns the attitude at a transition date for the old attitude law (the law previous to the valid transition law).
getOmega() - Method in class org.orekit.data.BodiesElements
Get the mean longitude of the ascending node of the Moon.
getOmegaInit() - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
 
getOmegaInverse() - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
Get the inverse of the covariance.
getOmegaRate() - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
 
getOne() - Method in class org.apache.commons.math3.complex.ComplexField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.dfp.Dfp
Get the constant 1.
getOne() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant 1.
getOne() - Method in interface org.apache.commons.math3.Field
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.fraction.BigFractionField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.fraction.FractionField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.util.BigRealField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math3.util.Decimal64Field
Get the multiplicative identity of the field.
getOneHarmonicValue(double, double, int) - Method in class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Get the value of the nth trigonometric contribution.
getOpposite() - Method in enum org.orekit.utils.IntervalEndpointType
Returns OPEN if the instance is CLOSED and CLOSED if the instance is OPEN.
getOptima() - Method in class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Gets all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
Gets all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultiStartMultivariateVectorOptimizer
Gets all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optim.univariate.MultiStartUnivariateOptimizer
Gets all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated. Get all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated. Get all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated. Get all the optima found during the last call to optimize.
getOrbit() - Method in class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
Returns the orbit.
getOrbit() - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
 
getOrbit() - Method in class org.orekit.propagation.SpacecraftState
Gets the current orbit.
getOrbitNatureConverter() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Get the mean/osculating orbit converter.
getOrbitType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Get propagation parameter type.
getOrbitType() - Method in class org.orekit.files.sp3.SP3File
Returns the SP3File.SP3OrbitType for this SP3 file.
getOrbitType() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get propagation parameter type.
getOrder() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the derivation order.
getOrder() - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the derivation order.
getOrder() - Method in class org.apache.commons.math3.analysis.polynomials.FourierDecompositionEngine
 
getOrder() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
 
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince54Integrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.DormandPrince853Integrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math3.ode.nonstiff.HighamHall54Integrator
Get the order of the method.
getOrder() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
 
getOrder() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
 
getOrderOfRegressors() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Gets the order of the regressors, useful if some type of reordering has been called.
getOrdinateGrid() - Method in class org.orekit.utils.InterpolationTableLoader
Returns a copy of the ordinate grid for the interpolation function.
getOrientation(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialSegment
Get the orientation from the quaternion polynomials at a given date.
getOrientation() - Method in class org.orekit.attitudes.Attitude
Get the complete orientation including spin and spin derivatives.
getOrientation(AbsoluteDate, Frame) - Method in class org.orekit.attitudes.DirectionTrackingOrientation
 
getOrientation(AbsoluteDate, Frame) - Method in interface org.orekit.attitudes.IOrientationLaw
Gets the rotation defining the orientation with respect to a given frame at a given date.
getOrientation(AbsoluteDate) - Method in class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Get the orientation at a given date.
getOrientation(AbsoluteDate) - Method in interface org.orekit.attitudes.kinematics.OrientationFunction
Get the orientation at a given date.
getOrientation() - Method in class org.orekit.frames.TopocentricFrame
 
getOrientedAngleBetween2Vector2D(Vector2D, Vector2D) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Computes the oriented angle between 2 vectors 2D.
getOrientedAngleBewteen2Vector3D(Vector3D, Vector3D, Vector3D) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Computes the oriented angle between 2 vectors 3D.
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
 
getOrigin() - Method in interface org.apache.commons.math3.geometry.euclidean.threed.InfiniteCone
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns the origin of the cone
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
This method returns the position of the cylinder on the Oxy plane
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCone
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get the line point closest to the origin.
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.LineSegment
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the origin point of the plane frame.
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
 
getOrigin() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Screw
 
getOrigin() - Method in class org.orekit.wrenches.Wrench
 
getOriginOffset() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the offset of the origin.
getOutline(PolyhedronsSet) - Method in class org.apache.commons.math3.geometry.euclidean.threed.OutlineExtractor
Extract the outline of a polyhedrons set.
getOutputPower() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
 
getP() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
Getter for p coefficient.
getP() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Returns the P rows permutation matrix.
getP() - Method in class org.apache.commons.math3.linear.LUDecomposition
Returns the P rows permutation matrix.
getPa() - Method in class org.orekit.data.BodiesElements
Get the general accumulated precession in longitude.
getParameter(String) - Method in interface org.apache.commons.math3.ode.ParameterizedODE
Get parameter value from its name.
getParameterEstimate(int) - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the parameter estimate for the regressor at the given index.
getParameterEstimates() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns a copy of the regression parameters estimates.
getParameterModels() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Get the array of parameter models.
getParameters() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Get underlying orbital parameters.
getParameters() - Method in class org.orekit.orbits.ApsisOrbit
Get underlying orbital parameters.
getParameters() - Method in class org.orekit.orbits.CartesianOrbit
Get underlying orbital parameters.
getParameters() - Method in class org.orekit.orbits.CircularOrbit
Get underlying orbital parameters.
getParameters() - Method in class org.orekit.orbits.EquatorialOrbit
Get underlying orbital parameters.
getParameters() - Method in class org.orekit.orbits.EquinoctialOrbit
Get underlying orbital parameters.
getParameters() - Method in class org.orekit.orbits.KeplerianOrbit
Get underlying orbital parameters.
getParameters() - Method in class org.orekit.orbits.Orbit
Get underlying orbital parameters.
getParameters() - Method in class org.orekit.parameter.ConstantFunction
Get the supported parameters.
getParameters() - Method in interface org.orekit.parameter.IParameterizable
Get the supported parameters.
getParameters() - Method in class org.orekit.parameter.LinearFunction
Get the supported parameters.
getParameters() - Method in class org.orekit.parameter.Parameterizable
Get the supported parameters.
getParameters() - Method in class org.orekit.parameter.PiecewiseFunction
Get the supported parameters.
getParameters() - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get the number of parameters.
getParametersJacobian(SpacecraftState, double[][]) - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get the Jacobian with respect to parameters.
getParametersJacobian(SpacecraftState) - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get the Jacobian with respect to parameters.
getParametersJacobian(Parameter, SpacecraftState, double[]) - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get the Jacobian with respect to provided parameter parameter.
getParametersJacobian(Parameter, SpacecraftState) - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get the Jacobian with respect to provided parameter parameter.
getParametersList() - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get parameters list.
getParametersNames() - Method in class org.apache.commons.math3.ode.AbstractParameterizable
Get the names of the supported parameters.
getParametersNames() - Method in interface org.apache.commons.math3.ode.Parameterizable
Get the names of the supported parameters.
getParent() - Method in interface fr.cnes.sirius.patrius.assembly.IPart
 
getParent() - Method in class fr.cnes.sirius.patrius.assembly.MainPart
Returns null : this part has no parent.
getParent() - Method in class fr.cnes.sirius.patrius.assembly.Part
 
getParent() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the parent node.
getParent() - Method in class org.orekit.frames.Frame
Get the parent frame.
getParentShape() - Method in class org.orekit.frames.TopocentricFrame
Get the body shape on which the local point is defined.
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 org.apache.commons.math3.stat.regression.MillerUpdatingRegression
In the original algorithm only the partial correlations of the regressors is returned to the user.
getPartialDensities(int) - Method in class org.orekit.forces.atmospheres.DTM2000
Get the local partial density of the selected element.
getPartialDerivative(int...) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get a partial derivative.
getPartialDerivativeIndex(int...) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the index of a partial derivative in the array.
getPartialDerivativeOrders(int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the derivation orders for a specific index in the array.
getPartLevel() - Method in interface fr.cnes.sirius.patrius.assembly.IPart
 
getPartLevel() - Method in class fr.cnes.sirius.patrius.assembly.MainPart
 
getPartLevel() - Method in class fr.cnes.sirius.patrius.assembly.Part
 
getPartName() - Method in class org.orekit.propagation.events.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 org.orekit.errors.OrekitException
Get the variable parts of the error message.
getPct(Comparable<?>) - Method in class org.apache.commons.math3.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(int) - Method in class org.apache.commons.math3.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(long) - Method in class org.apache.commons.math3.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(char) - Method in class org.apache.commons.math3.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPercentile(double) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns an estimate for the pth percentile of the stored values.
getPercentileImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured percentile implementation.
getPeriapsis() - Method in class org.orekit.orbits.ApsisOrbit
Get the periapsis.
getPeriapsis() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Get the periapsis.
getPeriapsisAltitude() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Get the periapsis altitude.
getPerigeeArgument() - Method in class org.orekit.orbits.ApsisOrbit
Get the perigee argument.
getPerigeeArgument() - Method in class org.orekit.orbits.KeplerianOrbit
Get the perigee argument.
getPerigeeArgument() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Get the perigee argument.
getPerigeeArgument() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Get the perigee argument.
getPerigeeArgument() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Get the perigee argument.
getPerigeeArgument() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the argument of perigee.
getPeriod() - Method in class org.apache.commons.math3.analysis.polynomials.FourierDecompositionEngine
 
getPeriod() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
 
getPeriod() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeriesApproximation
 
getPh() - Method in class org.apache.commons.math3.analysis.polynomials.HelmholtzPolynomial
Get the Hlm coefficients
getPhenomena(String, String, AbsoluteDateInterval) - Method in class fr.cnes.sirius.patrius.events.PhenomenaList
Finds one/more events in the list of Phenomenon following some criteria.
When a comment and a time interval are available, the method looks for a specific phenomenon in the list, otherwise if only the code is given as input, it looks for a list of phenomena with the same code.
getPhenomena() - 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.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.GenericCodingEventDetector
 
getPhenomenonCode() - Method in interface fr.cnes.sirius.patrius.events.multi.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.multi.MultiGenericCodingEventDetector
 
getPi() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant π.
getPiSplit() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant π split in two pieces.
getPivot() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Returns the pivot permutation vector.
getPivot() - Method in class org.apache.commons.math3.linear.LUDecomposition
Returns the pivot permutation vector.
getPivotPoint() - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Get the projection pivot point.
getPlus() - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Get the tree on the plus side of the cut hyperplane.
getPlus() - Method in class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Get the part of the sub-hyperplane on the plus side of the splitting hyperplane.
getPlusInside() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.orekit.bodies.CelestialBodyFactory
Get the Pluto singleton body.
getPoint(int) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get the simplex point stored at the requested index.
getPoint() - Method in class org.apache.commons.math3.optim.PointValuePair
Gets the point.
getPoint() - Method in class org.apache.commons.math3.optim.PointVectorValuePair
Gets the point.
getPoint() - Method in class org.apache.commons.math3.optim.univariate.UnivariatePointValuePair
Get the point.
getPoint(int) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Get the simplex point stored at the requested index.
getPoint() - Method in class org.apache.commons.math3.optimization.PointValuePair
Deprecated. Gets the point.
getPoint() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated. Gets the point.
getPoint() - Method in class org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair
Deprecated. Get the point.
getPoint() - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
Get the n-dimensional point in integer space.
getPoint() - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
Get the n-dimensional point in integer space.
getPoint() - Method in class org.orekit.frames.TopocentricFrame
Get the surface point defining the origin of the frame.
getPointAt(Vector2D, double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get one point from the 3D-space.
getPointAt(Vector1D, double) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.optim.PointValuePair
Gets a reference to the point.
getPointRef() - Method in class org.apache.commons.math3.optim.PointVectorValuePair
Gets a reference to the point.
getPointRef() - Method in class org.apache.commons.math3.optimization.PointValuePair
Deprecated. Gets a reference to the point.
getPointRef() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated. Gets a reference to the point.
getPoints() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get the points of the simplex.
getPoints() - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Get the points of the simplex.
getPoints() - Method in class org.apache.commons.math3.stat.clustering.Cluster
Get the points contained in the cluster.
getPolarMotion(AbsoluteDate) - Method in interface org.orekit.frames.configuration.FramesConfiguration
Compute corrected polar motion.
getPolarMotion(AbsoluteDate) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Compute corrected polar motion.
getPolarMotionModel() - Method in interface org.orekit.frames.configuration.FramesConfiguration
Get the polar motion model.
getPolarMotionModel() - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Get the polar motion model.
getPole(AbsoluteDate) - Method in interface org.orekit.bodies.IAUPole
Get the body North pole direction in EME2000 frame.
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Get the pole IERS Reference Pole correction.
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
Get the pole IERS Reference Pole correction.
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.NoEOP2000History
 
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.libration.IERS2010LibrationCorrection
This method provides the diurnal lunisolar effect on polar motion in time domain.
getPoleCorrection(AbsoluteDate) - Method in interface org.orekit.frames.configuration.libration.LibrationCorrectionModel
Compute the pole corrections at a given date.
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.libration.NoLibrationCorrection
Compute the pole corrections at a given date.
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.PolarMotion
Compute pole correction.
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.IERS2003TidalCorrection
Compute the pole corrections at a given date.
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.IERS2010TidalCorrection
Compute the pole corrections at a given date.
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.NoTidalCorrection
Compute the pole corrections at a given date.
getPoleCorrection() - Method in class org.orekit.frames.configuration.tides.TidalCorrection
 
getPoleCorrection(AbsoluteDate) - Method in interface org.orekit.frames.configuration.tides.TidalCorrectionModel
Compute the pole corrections at a given date.
getPoleCorrection(AbsoluteDate) - Method in class org.orekit.frames.transformations.TODProvider
Get the pole IERS Reference Pole correction.
getPolynomialOrder() - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
 
getPolynomials() - Method in class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Compute the interpolation polynomials.
getPolynomials() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get a copy of the interpolating polynomials array.
getPolynomials() - Method in class org.orekit.utils.HermiteInterpolator
Compute the interpolation polynomials.
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 .
getPolyOrder() - Method in class org.orekit.propagation.analytical.twod.DatePolynomialFunction
Returns polynomial order.
getPomega() - Method in class org.orekit.orbits.EquatorialOrbit
Get the longitude of the periapsis (ω + Ω).
getPomega() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Get the longitude of the periapsis (ω + Ω).
getPopulationLimit() - Method in class org.apache.commons.math3.genetics.ListPopulation
Access the maximum population size.
getPopulationLimit() - Method in interface org.apache.commons.math3.genetics.Population
Access the maximum population size.
getPopulationSize() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the population size.
getPopulationSize() - Method in class org.apache.commons.math3.genetics.ListPopulation
Access the current population size.
getPopulationSize() - Method in interface org.apache.commons.math3.genetics.Population
Access the current population size.
getPopulationSize() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer.PopulationSize
 
getPopulationSize() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer.PopulationSize
Deprecated.  
getPopulationVariance() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the population variance of the available values.
getPopulationVariance() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the population variance of the values that have been added.
getPopulationVariance() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the population variance of the values that have been added.
getPosition() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Get the position.
getPosition() - Method in class org.orekit.utils.CardanMountPosition
 
getPosition() - Method in class org.orekit.utils.CardanMountPV
 
getPosition() - Method in interface org.orekit.utils.Position
Gets the position.
getPosition() - Method in class org.orekit.utils.PVCoordinates
Gets the position.
getPosition() - Method in class org.orekit.utils.TopocentricPosition
 
getPosition() - Method in class org.orekit.utils.TopocentricPV
 
getPositionAngleType() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Get propagation parameter type.
getPositionAngleType() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get propagation parameter type.
getPositionTolerance() - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Get the desired position tolerance.
getPositionVelocity(AbsoluteDate) - Method in class org.orekit.bodies.PosVelChebyshev
Get the position-velocity at a specified date.
getPositivePolarForm() - Method in class org.apache.commons.math3.complex.Quaternion
Returns the polar form of the quaternion.
getPotentialProvider() - Static method in class org.orekit.forces.gravity.potential.GravityFieldFactory
Get the gravity field coefficients provider from the first supported file.
getPrecessionNutationModel() - Method in interface org.orekit.frames.configuration.FramesConfiguration
Get the precession nutation model.
getPrecessionNutationModel() - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Get the precession nutation model.
getPrecessionNutationModel() - Method in class org.orekit.frames.configuration.PrecessionNutation
 
getPrefix() - Method in class org.apache.commons.math3.geometry.VectorFormat
Get the format prefix.
getPrefix() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format prefix.
getPrefix() - Method in class org.apache.commons.math3.linear.RealVectorFormat
Get the format prefix.
getPress(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.US76
Get the local pressure for altitude in interval [0, 1E6] m
getPressure() - Method in class org.orekit.propagation.events.ApparentElevationDetector
Get the local pressure at topocentric frame origin.
getPrevious() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
 
getPrevious() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree.Node
Get the node containing the next smaller or equal element.
getPreviousAttitudeLeg(AttitudeLeg) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Gets the previous attitude law before the selected AttitudeLeg law.
getPreviousAttitudeLeg(String) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Gets the previous attitude law before the selected AttitudeLeg law.
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.MultiOrekitStepInterpolator
Get the previous grid date.
getPreviousDate() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
Get the previous grid date.
getPreviousDate() - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Get the previous grid date.
getPreviousDate() - Method in class org.orekit.propagation.sampling.BasicStepInterpolator
Get the previous grid date.
getPreviousDate() - Method in interface org.orekit.propagation.sampling.OrekitStepInterpolator
Get the previous grid date.
getPreviousIndex() - Method in class org.orekit.utils.AbstractBoundedPVProvider
Get the previous search index
getPreviousTime() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Get the previous soft grid point time.
getPreviousTime() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Get the previous grid point time.
getPrimary() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get the primary set of differential equations.
getPrimaryMapper() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get an equations mapper for the primary equations set.
getPrimaryState() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get primary part of the current state.
getPrimaryStateDot() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get primary part of the current state derivative.
getPrimeMeridianAngle(AbsoluteDate) - Method in interface org.orekit.bodies.IAUPole
Get the prime meridian angle.
getProbabilityOfSuccess() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Access the probability of success for this distribution.
getProbabilityOfSuccess() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Access the probability of success for this distribution.
getProcessNoise() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
Returns the process noise matrix.
getProcessNoise() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the process noise matrix.
getPropagator() - Method in class org.orekit.frames.SpacecraftFrame
Deprecated. Get the underlying propagator.
getPropagator() - Method in class org.orekit.propagation.analytical.AdapterPropagator
Get the reference propagator.
getProperInstance() - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Returns the default complex format for the current locale.
getProperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.BigFractionFormat
Returns the default complex format for the given locale.
getProperInstance() - Static method in class org.apache.commons.math3.fraction.FractionFormat
Returns the default complex format for the current locale.
getProperInstance(Locale) - Static method in class org.apache.commons.math3.fraction.FractionFormat
Returns the default complex format for the given locale.
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.
getProperty(PropertyType) - Method in class fr.cnes.sirius.patrius.assembly.MainPart
 
getProperty(PropertyType) - Method in class fr.cnes.sirius.patrius.assembly.Part
 
getProviders() - Method in class org.orekit.data.DataProvidersManager
Get an unmodifiable view of the list of supported providers.
getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Get the PVCoordinates of the sensor part in the selected 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(AbsoluteDate, Frame, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.stela.bodies.MeeusMoonStela
 
getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.stela.bodies.MeeusSunStela
 
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
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.tools.force.validation.BasicPVCoordinatesProvider
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.patrius.utils.AlmanacPVCoordinates
Geometric computation of the position to a date.
getPVCoordinates(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.validate.mocks.ephemeris.UserCelestialBody
Computes the PV coordinates at a date using linear interpolator.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.bodies.AbstractCelestialBody
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
 
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.bodies.MeeusMoon
 
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.bodies.MeeusSun
 
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.frames.SpacecraftFrame
Deprecated. Get the PVCoordinates of the spacecraft frame origin in the selected frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.frames.TopocentricFrame
Get the PVCoordinates of the topocentric frame origin in the selected frame.
getPVCoordinates(Frame) - Method in class org.orekit.orbits.Orbit
Get the PVCoordinates in a specified frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.orbits.Orbit
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates() - Method in class org.orekit.orbits.Orbit
Get the PVCoordinates in definition frame.
getPVCoordinates() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Get the PV coordinates.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.propagation.AbstractPropagator
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates(AbsoluteDate) - Method in class org.orekit.propagation.analytical.tle.TLEPropagator
Get the extrapolated position and velocity from an initial TLE.
getPVCoordinates(AbsoluteDate) - Method in class org.orekit.propagation.analytical.tle.TLESeries
Get the extrapolated position and velocity from an initial date.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.propagation.precomputed.Ephemeris
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.propagation.precomputed.IntegratedEphemeris
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates() - Method in class org.orekit.propagation.SpacecraftState
Get the PVCoordinates in orbit definition frame.
getPVCoordinates(Frame) - Method in class org.orekit.propagation.SpacecraftState
Get the PVCoordinates in given output frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.utils.EphemerisPvHermite
Get the PVCoordinates of the body in the selected frame.
getPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.utils.EphemerisPvLagrange
Frame can be null : by default the frame of expression is the frame used at instantiation (which is the frame of the first spacecraft state when instantiation is done from a table of spacecraft states).
getPVCoordinates(AbsoluteDate, Frame) - Method in interface org.orekit.utils.PVCoordinatesProvider
Get the PVCoordinates of the body in the selected frame.
getPVCoordinatesLagrange4(AbsoluteDate, Frame) - Method in class fr.cnes.sirius.validate.mocks.ephemeris.UserCelestialBody
Computes the PV coordinates at a date using Lagrange 4 interpolator.
getPVCoordinatesProvider() - Method in class org.orekit.propagation.events.AlignmentDetector
Get the body to align.
getPVFunction() - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Get the function computing position/velocity at sample points.
getPvProvider() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Get PV coordinates provider.
getPvProvider() - Method in class org.orekit.propagation.AbstractPropagator
Get PV coordinates provider.
getPVTarget() - Method in class org.orekit.propagation.events.CircularFieldOfViewDetector
Get the position/velocity provider of the target .
getPVTarget() - Method in class org.orekit.propagation.events.DihedralFieldOfViewDetector
Get the position/velocity provider of the target .
getQ() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
Getter for q coefficient.
getQ() - Method in class org.apache.commons.math3.linear.QRDecomposition
Returns the matrix Q of the decomposition.
getQ0() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the first component of the quaternion (scalar part).
getQ0() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the scalar coordinate of the quaternion.
getQ0Coefficients() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialProfile
 
getQ0Coefficients() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialSegment
 
getQ0FourierSeries() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
 
getQ1() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the second component of the quaternion (first component of the vector part).
getQ1() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the first coordinate of the vectorial part of the quaternion.
getQ1Coefficients() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialProfile
 
getQ1Coefficients() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialSegment
 
getQ1FourierSeries() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
 
getQ2() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the third component of the quaternion (second component of the vector part).
getQ2() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the second coordinate of the vectorial part of the quaternion.
getQ2Coefficients() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialProfile
 
getQ2Coefficients() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialSegment
 
getQ2FourierSeries() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
 
getQ3() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the fourth component of the quaternion (third component of the vector part).
getQ3() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Get the third coordinate of the vectorial part of the quaternion.
getQ3Coefficients() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialProfile
 
getQ3Coefficients() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialSegment
 
getQ3FourierSeries() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
 
getQi() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the normalized quaternion in double[] type : {q0, q1, q2, q3}.
getQT() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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.tools.ephemerisComparator.QuaternionDPFacade
 
getQuaternion() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get the normalized quaternion.
getR() - Method in class org.apache.commons.math3.linear.QRDecomposition
Returns the matrix R of the decomposition.
getR() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns Pearson's product moment correlation coefficient, usually denoted r.
getR12(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.signalpropagation.iono.R12Loader
 
getR12(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.signalpropagation.iono.R12Provider
Provides the R12 value for the Bent model.
getRaan() - Method in class org.orekit.propagation.analytical.tle.TLE
Get Right Ascension of the Ascending node.
getRadius() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
 
getRadius() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
 
getRadius() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
 
getRadiusA() - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
 
getRadiusA() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
 
getRadiusB() - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
 
getRadiusB() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
 
getRadixDigits() - Method in class org.apache.commons.math3.dfp.Dfp
Get the number of radix digits of the instance.
getRadixDigits() - Method in class org.apache.commons.math3.dfp.DfpField
Get the number of radix digits of the Dfp instances built by this factory.
getRandomGenerator() - Static method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the (static) random generator.
getRange(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the range of a point with regards to the topocentric frame center point.
getRange() - Method in class org.orekit.utils.CardanMountPosition
Get the range.
getRange() - Method in class org.orekit.utils.CardanMountPV
Get the range.
getRange() - Method in class org.orekit.utils.TopocentricPosition
Get the range.
getRange() - Method in class org.orekit.utils.TopocentricPV
Get the range.
getRangeRate(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the range rate of a point with regards to the topocentric frame center point.
getRangeRate() - Method in class org.orekit.utils.CardanMountPV
Get the range rate.
getRangeRate() - Method in class org.orekit.utils.TopocentricPV
Get the range rate.
getRank() - Method in class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
Get the rank of the symmetric positive semidefinite matrix.
getRank() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Return the effective numerical matrix rank.
getRank() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Get the rank of the covariance matrix.
getRank() - Method in class org.apache.commons.math3.random.UniformlyCorrelatedRandomVectorGenerator
Get the rank of the covariance matrix.
getRankCorrelation() - Method in class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Returns a PearsonsCorrelation instance constructed from the ranked input data.
getRatio() - Method in class org.apache.commons.math3.genetics.UniformCrossover
Returns the mixing ratio used by this CrossoverPolicy.
getRawComparisonData() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
 
getRawProvider() - Method in class org.orekit.frames.transformations.InterpolatingTransformProvider
Get the underlying provider for raw (non-interpolated) transforms.
getReal() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the real value of the number.
getReal() - Method in class org.apache.commons.math3.complex.Complex
Access the real part.
getReal(int) - Method in class org.apache.commons.math3.complex.RootsOfUnity
Get the real part of the k-th n-th root of unity.
getReal() - Method in interface org.apache.commons.math3.RealFieldElement
Get the real value of the number.
getRealEigenvalue(int) - Method in class org.apache.commons.math3.linear.EigenDecomposition
Returns the real part of the ith eigenvalue of the original matrix.
getRealEigenvalues() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets a copy of the real parts of the eigenvalues of the original matrix.
getRealFormat() - Method in class org.apache.commons.math3.complex.ComplexFormat
Access the realFormat.
getRealMatrix() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
 
getRealVector() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a RealVector with identical data.
getReducedFraction(int, int) - Static method in class org.apache.commons.math3.fraction.BigFraction
Creates a BigFraction instance with the 2 parts of a fraction Y/Z.
getReducedFraction(int, int) - Static method in class org.apache.commons.math3.fraction.Fraction
Creates a Fraction instance with the 2 parts of a fraction Y/Z.
getReentryParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double, double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double) - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Convert current orbital parameters into reentry parameters.
getReentryParameters(double, double) - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Convert current orbital parameters into reentry parameters.
getReference() - Method in class fr.cnes.sirius.patrius.projections.AbstractProjection
Get the system of reference used.
getReference() - Method in interface fr.cnes.sirius.patrius.projections.IProjection
Get the system of reference used.
getReference() - Method in class fr.cnes.sirius.patrius.utils.AngleInterval
 
getReferenceAttitude() - Method in class org.orekit.attitudes.FixedRate
Get the reference attitude.
getReferenceAxis() - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
 
getReferenceDate() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Get the reference date
getReferenceDate() - Method in class org.orekit.utils.SecularAndHarmonic
Get the reference date.
getReferenceFrame() - Method in interface fr.cnes.sirius.validate.mocks.ephemeris.IUserEphemeris
 
getReferenceFrame() - Method in class fr.cnes.sirius.validate.mocks.ephemeris.UserEphemeris
 
getReferenceFrame() - Method in class org.orekit.attitudes.Attitude
Get the reference frame.
getRefrenceAxis(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
getRegressionSumSquares() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.optim.linear.LinearConstraint
Gets the relationship between left and right hand sides.
getRelationship() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated. Get the relationship between left and right hand sides.
getRelativeAccuracy() - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Get the actual relative accuracy.
getRelativeAccuracy() - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Get the actual relative accuracy.
getRelativeAccuracy() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Get the relative accuracy of the solver.
getRelativeAccuracy() - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Get the relative accuracy of the solver.
getRelativeAccuracy() - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Get the relative accuracy.
getRelativeComparisonData() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
 
getRelativeThreshold() - Method in class org.apache.commons.math3.optim.AbstractConvergenceChecker
 
getRelativeThreshold() - Method in class org.apache.commons.math3.optimization.AbstractConvergenceChecker
Deprecated.  
getRemainingRegion() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Get the remaining region of the hyperplane.
getRepresentation() - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
Returns the (immutable) inner representation of the chromosome.
getResidual() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns the residual.
getResidual() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns the residual.
getResiduals(double[]) - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Get the residuals for a given position/velocity/B* parameters set.
getResult() - Method in class fr.cnes.sirius.validate.parallel.AbstractSimpleParallelTaskImpl
 
getResult() - Method in interface fr.cnes.sirius.validate.parallel.ParallelTask
Asynchronous getter for the results.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Returns the value of the statistic based on the values that have been added.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Get the covariance matrix.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
Get the mean vector.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Returns the current value of the Statistic.
getResult() - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Returns the current value of the Statistic.
getResultSummary() - Method in class fr.cnes.sirius.validate.parallel.ParallelRunner
Gets the result summary.
getReverse() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the reverse of the instance.
getRevolutionNumberAtEpoch() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the revolution number.
getRightAscensionOfAscendingNode() - Method in class org.orekit.orbits.ApsisOrbit
Get the right ascension of the ascending node.
getRightAscensionOfAscendingNode() - Method in class org.orekit.orbits.CircularOrbit
Get the right ascension of the ascending node.
getRightAscensionOfAscendingNode() - Method in class org.orekit.orbits.KeplerianOrbit
Get the right ascension of the ascending node.
getRightAscensionOfAscendingNode() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Get the right ascension of the ascending node.
getRightAscensionOfAscendingNode() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Get the right ascension of the ascending node.
getRightAscensionOfAscendingNode() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Get the right ascension of the ascending node.
getRightAscensionOfAscendingNode() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Get the right ascension of the ascending node.
getRightHandSideVector() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns the current right-hand side of the linear system to be solved.
getRightHandSideVector() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns the current right-hand side of the linear system to be solved.
getRMS() - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Gets the root-mean-square (RMS) value.
getRMS() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. Get the Root Mean Square value.
getRMS() - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Get Root Mean Square of the fitting.
getRMS(double[]) - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Get the RMS for a given position/velocity/B* parameters set.
getRolloverWeeks() - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
Returns almanach unambiguous week number.
getRolloverWeeks() - Method in class fr.cnes.sirius.patrius.utils.GalileoAlmanacParameters
 
getRolloverWeeks() - Method in class fr.cnes.sirius.patrius.utils.GPSAlmanacParameters
 
getRoot() - Static method in class org.orekit.frames.Frame
Get the unique root frame.
getRootMatrix() - Method in class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
Get the root of the covariance matrix.
getRootMatrix() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Get the root of the covariance matrix.
getRootMatrix() - Method in class org.apache.commons.math3.random.UniformlyCorrelatedRandomVectorGenerator
Get the root of the correlation matrix.
getRotation() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.RotationDPFacade
 
getRotation() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Screw
 
getRotation() - Method in class org.orekit.attitudes.Attitude
Get the attitude rotation.
getRotation() - Method in class org.orekit.frames.transformations.Transform
Get the orientation of the "destination" frame in the "origin" one.
getRotation() - Method in class org.orekit.utils.AngularCoordinates
Get the rotation.
getRotationAcceleration() - Method in class org.orekit.attitudes.Attitude
Get the satellite rotation acceleration.
getRotationAcceleration() - Method in class org.orekit.frames.transformations.Transform
Get the second time derivative of the rotation.
getRotationAcceleration() - Method in class org.orekit.utils.AngularCoordinates
Get the rotation acceleration.
getRotationRate(AbsoluteDate) - Static method in class org.orekit.frames.transformations.GTODProvider
Get the rotation rate of the Earth.
getRotationRate() - Method in class org.orekit.frames.transformations.Transform
Get the rotation rate of the "destination" frame in the "origin" one.
getRotationRate() - Method in class org.orekit.utils.AngularCoordinates
Get the rotation rate.
getRoundingMode() - Method in class org.apache.commons.math3.dfp.DfpField
Get the current rounding mode.
getRoundingMode() - Method in class org.apache.commons.math3.util.BigReal
Gets the rounding mode for division operations The default is RoundingMode.HALF_UP
getRow(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given row index.
getRow(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given row index.
getRow(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in row number row as an array.
getRow() - Method in exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
 
getRow() - Method in exception org.apache.commons.math3.linear.NonSymmetricMatrixException
 
getRow(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given row index.
getRowDimension() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - Method in interface org.apache.commons.math3.linear.AnyMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the number of rows of this matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the number of rows of this matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
Returns the dimension of the codomain of this operator.
getRowDimension() - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Returns the number of rows of this matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns the dimension of the codomain of this operator.
getRowDimension() - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns the number of rows of this matrix.
getRowMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get the entries at the given row index as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Get the entries at the given row index as a row matrix.
getRowMatrix(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in row number row as a row matrix.
getRowMatrix(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Get the entries at the given row index as a row matrix.
getRowPrefix() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format prefix.
getRowSeparator() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format separator between rows of the matrix.
getRowSuffix() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format suffix.
getRowVector(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get the entries in row number row as a vector.
getRowVector(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get the entries in row number row as a vector.
getRowVector(int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get the entries in row number row as a vector.
getRowVector(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the entries in row number row as a vector.
getRSquare() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the coefficient of determination, usually denoted r-square.
getRSquared() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the coefficient of multiple determination, usually denoted r-square.
getRule(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.BaseRuleFactory
Gets a copy of the quadrature rule with the given number of integration points.
getRuleInternal(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.BaseRuleFactory
Gets a rule.
getRuntimeClass() - Method in class org.apache.commons.math3.complex.ComplexField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.dfp.DfpField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in interface org.apache.commons.math3.Field
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.fraction.BigFractionField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.fraction.FractionField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.util.BigRealField
Returns the runtime class of the FieldElement.
getRuntimeClass() - Method in class org.apache.commons.math3.util.Decimal64Field
Returns the runtime class of the FieldElement.
getS() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the diagonal matrix Σ of the decomposition.
getS(int, int, boolean) - Method in interface org.orekit.forces.gravity.potential.PotentialCoefficientsProvider
Get tesseral-sectorial coefficients.
getS(int, int, boolean) - Method in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Get tesseral-sectorial coefficients.
getS() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
 
getS() - Method in class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
 
getS10(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.JB2006InputParameters
Get the EUV index (26-34 nm) scaled to F10.
getS10B(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.JB2006InputParameters
Get the EUV 81-day averaged centered index.
getSafety() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Get the safety factor for stepsize control.
getSafety() - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the safety factor for stepsize control.
getSampleSize() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the sample size.
getSampleStats() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns a StatisticalSummary describing this distribution.
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 org.orekit.files.general.OrbitFile
Get additional information about a satellite.
getSatellite(String) - Method in class org.orekit.files.sp3.SP3File
Get additional information about a satellite.
getSatellite(int) - Method in class org.orekit.files.sp3.SP3File
Returns the nth satellite as contained in the SP3 file.
getSatelliteCoordinates(String) - Method in interface org.orekit.files.general.OrbitFile
Get the time coordinates for the given satellite.
getSatelliteCoordinates(String) - Method in class org.orekit.files.sp3.SP3File
Get the time coordinates for the given satellite.
getSatelliteCount() - Method in interface org.orekit.files.general.OrbitFile
Get the number of satellites contained in this orbit file.
getSatelliteCount() - Method in class org.orekit.files.sp3.SP3File
Get the number of satellites contained in this orbit file.
getSatelliteId() - Method in class org.orekit.files.general.SatelliteInformation
Returns the id for this satellite object.
getSatelliteNumber() - Method in class org.orekit.propagation.analytical.tle.TLE
Get the satellite id.
getSatellites() - Method in interface org.orekit.files.general.OrbitFile
Returns a Collection of SatelliteInformation objects for all satellites contained in this orbit file.
getSatellites() - Method in class org.orekit.files.sp3.SP3File
Returns a Collection of SatelliteInformation objects for all satellites contained in this orbit file.
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.
getSatSize(String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
Get the state vector size of the given spacecraft .
getSaturn() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Saturn singleton body.
getSc() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
 
getScalarPart() - Method in class org.apache.commons.math3.complex.Quaternion
Gets the scalar part of the quaternion.
getScale() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Access the scale parameter.
getScale() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Returns the scale parameter of this distribution.
getScale() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Returns the scale parameter of this distribution.
getScale() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Access the scale parameter, beta.
getScale() - Method in class org.apache.commons.math3.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.
getSearchIndex() - Method in class org.orekit.utils.AbstractBoundedPVProvider
Get the optimize indice search algorithm
getSec() - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Getter for sec.
getSecond() - Method in class org.apache.commons.math3.genetics.ChromosomePair
Access the second chromosome.
getSecond() - Method in class org.apache.commons.math3.util.Pair
Get the second element of the pair.
getSecond() - Method in class org.orekit.time.TimeComponents
Get the seconds number.
getSecondaryMappers() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get the equations mappers for the secondary equations sets.
getSecondarySpacecraft() - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
Get the secondary assembly to consider.
getSecondaryState(int) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get secondary part of the current state.
getSecondaryStateDot(int) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get secondary part of the current state derivative.
getSecondBody() - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Get 2nd body
getSecondBody() - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
Get 2nd body.
getSecondCovarianceMatrix() - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
 
getSecondFileColumnIndexes() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
get the column indexes of the second file
getSecondFileColumnTypes() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
get the column indexes of the second file
getSecondFileType() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
get the type of the first file.
getSecondMoment() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns a statistic related to the Second Central Moment.
getSecondMoment() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns a statistic related to the Second Central Moment.
getSecondsInDay() - Method in class org.orekit.time.TimeComponents
Get the second number within the day.
getSecondsOfWeek() - Method in class org.orekit.files.sp3.SP3File
Returns the seconds of the GPS week as contained in the SP3 file.
getSegments() - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Get the endpoints of the sub-line.
getSegments() - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Get the endpoints of the sub-line.
getSelectionPolicy() - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Returns the selection policy.
getSemiA() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Get the length of the semi principal axis X
getSemiA() - Method in interface org.apache.commons.math3.geometry.euclidean.threed.IEllipsoid
Get semi axis A
getSemiA() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Get semi axis A
getSemiAxisA() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
This method returns the semi axis a
getSemiAxisB() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
This method returns the semi axis b
getSemiAxisX() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns the semi axis of the cone along X axis
getSemiAxisY() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns the semi axis of the cone along Y axis
getSemiB() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Get the length of the semi principal axis Y
getSemiB() - Method in interface org.apache.commons.math3.geometry.euclidean.threed.IEllipsoid
Get semi axis B
getSemiB() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Get semi axis B
getSemiC() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Get the length of the semi principal axis Z
getSemiC() - Method in interface org.apache.commons.math3.geometry.euclidean.threed.IEllipsoid
Get semi axis C
getSemiC() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Get semi axis C
getSemiPrincipalX() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
 
getSemiPrincipalY() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
 
getSemiPrincipalZ() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
 
getSensor() - Method in class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Get the sensor.
getSensor() - Method in class fr.cnes.sirius.patrius.events.sensor.SensorInhibitionDetector
Get the sensor.
getSensor() - Method in class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
Get the sensor.
getSensor() - Method in class fr.cnes.sirius.patrius.events.sensor.StationToSatMutualVisibilityDetector
Get the sensor.
getSensor() - Method in class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
Get the sensor.
getSensorMainSpacecraft() - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
Get the main spacecraft sensor.
getSensorName() - Method in class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Get the sensor name.
getSensorSecondarySpacecraft() - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
Get the secondary spacecraft sensor.
getSeparator() - Method in class org.apache.commons.math3.geometry.VectorFormat
Get the format separator between components.
getSeparator() - Method in class org.apache.commons.math3.linear.RealVectorFormat
Get the format separator between components.
getSequence() - Method in class org.orekit.attitudes.AttitudeLegsSequence
Returns a copy of the map containing of all AttitudeLeg instances.
getSeries() - Method in class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Getter for series.
getShape() - Method in class fr.cnes.sirius.patrius.assembly.properties.GeometricProperty
 
getShape() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Returns the shape parameter of this distribution.
getShape() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Returns the shape parameter of this distribution.
getShape() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Access the shape parameter, alpha.
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.sensor.ExtremaSightAxisDetector
Get the sight axis
getSigma() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer.Sigma
 
getSigma() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer.Sigma
Deprecated.  
getSigma() - Method in class org.apache.commons.math3.random.ValueServer
Returns the standard deviation used when operating in ValueServer.GAUSSIAN_MODE.
getSignalTropoCorrection(TroposphericCorrection, SignalPropagation, TopocentricFrame) - Method in class fr.cnes.sirius.patrius.signalpropagation.SignalPropagationModel
Computes the tropospheric effects corrections to be applied to a given PropagationSignal object.
getSignificance() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the significance level of the slope (equiv) correlation.
getSinArray() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
 
getSinArrays() - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesHarmonicProfile
 
getSinArrays() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
 
getSingularValues() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the diagonal elements of the matrix Σ of the decomposition.
getSize() - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
 
getSize() - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Get the array size required for holding partial derivatives data.
getSize() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Get the size of the interval.
getSize() - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
Get the size of the instance.
getSize() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the size of the instance.
getSize() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Get the size of the instance.
getSize() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the size of the instance.
getSize() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Get the size of the instance.
getSize() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Get simplex size.
getSize() - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Get simplex size.
getSize() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Get the total number of elements.
getSize() - Method in class org.orekit.propagation.numerical.AdditionalStateInfo
Get the size of the additional state.
getSizes() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Get the number of multidimensional counter slots in each dimension.
getSkewness() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the skewness of the available values.
getSkewnessImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured skewness implementation.
getSlope() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the slope of the estimated regression line.
getSlope() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Getter for slope of velocity.
getSlopeConfidenceInterval() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the half-width of a 95% confidence interval for the slope estimate.
getSlopeConfidenceInterval(double) - Method in class org.apache.commons.math3.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.GenericCodingEventDetector
 
getSlopeSelection() - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
getSlopeSelection() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMonoEventDetector
 
getSlopeSelection() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMultiEventDetector
 
getSlopeSelection() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
 
getSlopeSelection() - Method in interface org.apache.commons.math3.ode.events.EventHandler
Get the parameter in charge of the selection of detected events by the slope of the g-function.
getSlopeSelection() - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Get the parameter in charge of the selection of detected events by the slope of the g-function.
getSlopeSelection() - Method in class org.orekit.propagation.events.AbstractDetector
Get the parameter in charge of the selection of detected events by the slope of the g-function.
getSlopeSelection() - Method in class org.orekit.propagation.events.AdaptedEventDetector
Get the parameter in charge of the selection of detected events by the slope of the g-function.
getSlopeSelection() - Method in interface org.orekit.propagation.events.EventDetector
Get the parameter in charge of the selection of detected events by the slope of the g-function.
getSlopeSelection() - Method in interface org.orekit.propagation.events.multi.MultiEventDetector
Get the parameter in charge of the selection of detected events by the slope of the g-function.
getSlopeSelection() - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Get the parameter in charge of the selection of detected events by the slope of the g-function.
getSlopeStdErr() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the standard error of the slope estimate, usually denoted s(b1).
getSlots() - Method in class org.orekit.utils.TimeStampedCache
Get the number of slots in use.
getSlotsEvictions() - Method in class org.orekit.utils.TimeStampedCache
Get the number of slots evictions.
getSmallest() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Get the node whose element is the smallest one in the tree.
getSmaModel() - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Get the semi major axis parameter model.
getSolarActivityDataProvider() - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataFactory
Get the solar activity provider from the first supported file.
getSolarSystemBarycenter() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the solar system barycenter aggregated body.
getSolution() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns the current estimate of the solution to the linear system to be solved.
getSolution() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns the current estimate of the solution to the linear system to be solved.
getSolver() - Method in class org.apache.commons.math3.linear.CholeskyDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in class org.apache.commons.math3.linear.LUDecomposition
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in class org.apache.commons.math3.linear.QRDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in interface org.apache.commons.math3.linear.UDDecomposition
Get a solver of the linear equation A × X = B for matrices A.
getSolver() - Method in class org.apache.commons.math3.linear.UDDecompositionImpl
 
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Return the absolute accuracy setting of the solver used to estimate inverse cumulative probabilities.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.FDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.TDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Returns the solver absolute accuracy for inverse cumulative computation.
getSolverAbsoluteAccuracy() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Return the absolute accuracy setting of the solver used to estimate inverse cumulative probabilities.
getSortedValues() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives, sorted in ascending order.
getSourceString() - Method in enum fr.cnes.sirius.patrius.exception.util.PatriusMessages
Gets the source (non-localized) string.
getSourceString() - Method in enum fr.cnes.sirius.patrius.tools.exception.util.ToolsMessages
Gets the source (non-localized) string.
getSourceString() - Method in class org.apache.commons.math3.exception.util.DummyLocalizable
Gets the source (non-localized) string.
getSourceString() - Method in interface org.apache.commons.math3.exception.util.Localizable
Gets the source (non-localized) string.
getSourceString() - Method in enum org.apache.commons.math3.exception.util.LocalizedFormats
Gets the source (non-localized) string.
getSourceString() - Method in enum org.orekit.errors.OrekitAddonsMessages
Gets the source (non-localized) string.
getSourceString() - Method in enum org.orekit.errors.OrekitMessages
Gets the source (non-localized) string.
getSouth() - Method in class org.orekit.bodies.GeodeticPoint
Get the direction to the south of point, expressed in parent shape frame.
getSouth() - Method in class org.orekit.frames.TopocentricFrame
Get the south direction of topocentric frame, expressed in parent shape frame.
getSP(AbsoluteDate) - Method in class org.orekit.frames.configuration.PolarMotion
Compute S'.
getsP() - Method in class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
 
getSP(AbsoluteDate) - Method in class org.orekit.frames.configuration.sp.IERS2010SPCorrection
Compute the correction S' at a given date.
getSP(AbsoluteDate) - Method in class org.orekit.frames.configuration.sp.NoSpCorrection
Compute the correction S' at a given date.
getSP(AbsoluteDate) - Method in interface org.orekit.frames.configuration.sp.SPrimeModel
Compute the correction S' at a given date.
getSpace() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the space to which the vector belongs.
getSpace() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the space to which the vector belongs.
getSpace() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the space to which the vector belongs.
getSpace() - Method in interface org.apache.commons.math3.geometry.Vector
Get the space to which the vector belongs.
getSparsity() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated.  
getSpecifier() - Method in exception org.orekit.errors.OrekitException
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.stela.forces.atmospheres.MSIS00Adapter
Get the local speed of sound.
getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in interface org.orekit.forces.atmospheres.Atmosphere
Get the local speed of sound.
getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.DTM2000
Get the local speed of sound.
getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.HarrisPriester
Get the local speed of sound.
getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.JB2006
Get the local speed of sound.
getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.MSISE2000
Get the local speed of sound.
getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.SimpleExponentialAtmosphere
Get the local speed of sound.
getSpeedOfSound(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.US76
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.
getSpin() - Method in class org.orekit.attitudes.Attitude
Get the satellite spin.
getSpinDerivatives(AbsoluteDate, Frame) - Method in class org.orekit.attitudes.TwoSpinBiasSlew
get the spin derivatives (default implementation : finite differences differentiator).
getSpinDerivativesComputation() - Method in class org.orekit.attitudes.AbstractAttitudeLaw
Get the value of the flag indicating if spin derivation computation is activated.
getSpinFunction(Frame, AbsoluteDate) - Method in class org.orekit.attitudes.TwoSpinBiasSlew
 
getSprime(AbsoluteDate) - Method in interface org.orekit.frames.configuration.FramesConfiguration
Compute S' value.
getSprime(AbsoluteDate) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Compute S' value.
getSPrimeModel() - Method in class org.orekit.frames.configuration.PolarMotion
 
getSqr2() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √2.
getSqr2Reciprocal() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √2 / 2.
getSqr2Split() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √2 split in two pieces.
getSqr3() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √3.
getSqr3Reciprocal() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant √3 / 3.
getSqrtA() - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
 
getSquareRoot() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Computes the square-root of the matrix.
getSquaringJDCNES() - Static method in class fr.cnes.sirius.patrius.stela.forces.Squaring
 
getStandard() - Method in interface org.orekit.forces.gravity.tides.IOceanTidesDataProvider
Get the ocean tides standard
getStandard() - Method in interface org.orekit.forces.gravity.tides.ITerrestrialTidesDataProvider
 
getStandard() - Method in class org.orekit.forces.gravity.tides.OceanTidesDataProvider
 
getStandard() - Method in class org.orekit.forces.gravity.tides.TerrestrialTidesDataProvider
 
getStandardBasisTransform() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Get transformation matrix (from ellipsoid local basis to standard basis)
getStandardBasisTransform() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns the matrix of the transformation to the standard basis
getStandardBasisTransform() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
This method returns the matrix of the transformation to the standard basis
getStandardDeviation() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Access the standard deviation.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getStandardDeviation() - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the standard deviation of the values that have been added.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getStandardDeviation() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the standard deviation of the values that have been added.
getStandardDeviations() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ComparisonData
gets the standard deviation of all the columns in a list.
getStandardDeviations() - Method in class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Gets the square root of each element on the diagonal of the covariance matrix.
getStandardDeviationVector() - Method in class org.apache.commons.math3.random.UniformlyCorrelatedRandomVectorGenerator
Get the standard deviation vector.
getStandardModel() - Static method in class org.orekit.models.earth.SaastamoinenModel
Create a new Saastamoinen model using a standard atmosphere model.
getStart() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Segment
Get the start point of the segment.
getStart() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Segment
Get the start point of the segment.
getStartDate() - Method in class fr.cnes.sirius.patrius.signalpropagation.SignalPropagation
 
getStartDate() - Method in class org.orekit.forces.maneuvers.ConstantThrustError
Return the maneuver start date (if a date or a DateDetector as been provided).
getStartDate() - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Return the maneuver start date (if a date or a DateDetector as been provided).
getStartDate() - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Return the maneuver start date (if a date or a DateDetector as been provided).
getStartDate() - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Get the date of the first available Earth Orientation Parameters.
getStartDate() - Method in class org.orekit.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
 
getStartDate() - Method in interface org.orekit.frames.configuration.eop.EOPHistory
Get the date of the first available Earth Orientation Parameters.
getStartDate() - Method in class org.orekit.frames.configuration.eop.NoEOP2000History
getStartDate.
getStarterIntegrator() - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Get the starter integrator.
getStartIndex() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns the "start index" of the internal array.
getStartingEvent() - Method in class fr.cnes.sirius.patrius.events.Phenomenon
Get the starting event.
getStartingIsDefined() - Method in class fr.cnes.sirius.patrius.events.Phenomenon
True if the first boundary value is defined.
getStartPoint() - Method in class org.apache.commons.math3.optim.BaseMultivariateOptimizer
Gets the initial guess.
getStartPoint() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.  
getStartPoint() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Gets the initial values of the optimized parameters.
getStartValue() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
 
getStartValue() - Method in class org.apache.commons.math3.optim.univariate.SearchInterval
Gets the start value.
getStartValue() - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
 
getStartValue() - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated.  
getState() - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger.LoggedCodedEvent
Gets the SpacecraftState that caused the coded event.
getState() - Method in class org.orekit.propagation.events.EventsLogger.LoggedEvent
Get the triggering state.
getStateDimension() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns the dimension of the state estimation vector.
getStateDimension() - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get the state vector dimension.
getStateEstimation() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns the current state estimation vector.
getStateEstimationVector() - Method in class org.apache.commons.math3.filter.KalmanFilter
Returns a copy of the current state estimation vector.
getStateJacobian(SpacecraftState, double[][]) - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get the Jacobian with respect to state.
getStateJacobian(SpacecraftState) - Method in class org.orekit.propagation.numerical.JacobiansMapper
Get the Jacobian with respect to state.
getStates() - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger.MultiLoggedCodedEvent
Gets the map of SpacecraftState that caused the coded event.
getStates() - Method in class fr.cnes.sirius.patrius.events.multi.MultiEventsLogger.MultiLoggedEvent
Get the triggering states.
getStateTransitionMatrix() - Method in class org.apache.commons.math3.filter.DefaultProcessModel
Returns the state transition matrix.
getStateTransitionMatrix() - Method in interface org.apache.commons.math3.filter.ProcessModel
Returns the state transition matrix.
getStateVectorSize() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
Get global state vector size.
getStateVectorSize() - Method in class org.orekit.propagation.SpacecraftState
Get the state vector size.
getStation() - Method in class fr.cnes.sirius.patrius.events.sensor.AbstractDetectorWithTropoCorrection
Get the station.
getStatisticsDHistory() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
getStatisticsDHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.  
getStatisticsFitnessHistory() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
getStatisticsFitnessHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.  
getStatisticsMeanHistory() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
getStatisticsMeanHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.  
getStatisticsSigmaHistory() - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
 
getStatisticsSigmaHistory() - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated.  
getStdErrorOfEstimate(int) - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the standard error of the parameter estimate at index, usually denoted s(bindex).
getStdErrorOfEstimates() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the standard error of the parameter estimates, usually denoted s(bi).
getStelaConfiguration() - Static method in class org.orekit.frames.configuration.FramesConfigurationFactory
Gets the official STELA configuration (always the same instance, not a new one).
getStelaEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters(double) - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters() - Method in interface org.orekit.orbits.orbitalparameters.IOrbitalParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Convert current orbital parameters into Stela equinoctial parameters.
getStelaEquinoctialParameters() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Convert current orbital parameters into Stela equinoctial parameters.
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
 
getStepHandlers() - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Get all the step handlers that have been added to the integrator.
getStepHandlers() - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Get all the step handlers that have been added to the integrator.
getStepSize() - Method in class org.apache.commons.math3.analysis.differentiation.FiniteDifferencesDifferentiator
Get the step size.
getStream(File) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.AbstractDataLoader
Produces a BufferedReader from a File object.
getStream(URL) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.AbstractDataLoader
Produces a BufferedReader from a url to a text file.
getStrengthLevel() - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Get the strength level for activity.
getStrict() - Method in exception org.apache.commons.math3.exception.NonMonotonicSequenceException
 
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get a submatrix.
getSubMatrix(int[], int[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get a submatrix.
getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Get a submatrix.
getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Gets a submatrix.
getSubSpace() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Euclidean1D
Get the n-1 dimension subspace of this space.
getSubSpace() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Euclidean3D
Get the n-1 dimension subspace of this space.
getSubSpace() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Euclidean2D
Get the n-1 dimension subspace of this space.
getSubSpace() - Method in interface org.apache.commons.math3.geometry.Space
Get the n-1 dimension subspace of this space.
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in interface org.apache.commons.math3.linear.FieldVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.RealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Get a subvector from consecutive elements.
getSuffix() - Method in class org.apache.commons.math3.geometry.VectorFormat
Get the format suffix.
getSuffix() - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Get the format suffix.
getSuffix() - Method in class org.apache.commons.math3.linear.RealVectorFormat
Get the format suffix.
getSum() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSum() - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getSum() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the sum of the values that have been added
getSum() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the sum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSum() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the sum of the values that have been added
getSumFreq() - Method in class org.apache.commons.math3.stat.Frequency
Returns the sum of all frequencies.
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured sum implementation.
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured Sum implementation
getSumLog() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumLog() - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured sum of logs implementation
getSummary() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Return a StatisticalSummaryValues instance reporting current aggregate statistics.
getSummary() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Return a StatisticalSummaryValues instance reporting current statistics.
getSummary() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Return a StatisticalSummaryValues instance reporting current statistics.
getSumOfCrossProducts() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of crossproducts, xi*yi.
getSumOfLogs() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the sum of the logs of all the aggregated data.
getSumOfLogs() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the sum of the logs of the values that have been added.
getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the sum of the squares of all the aggregated data.
getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the sum of the squares of the available values.
getSumSq() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumSq() - Method in interface org.apache.commons.math3.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 org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the sum of the squares of the values that have been added.
getSumSq() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumsq() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the sum of the squares of the values that have been added.
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured sum of squares implementation.
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured sum of squares implementation
getSumSquaredErrors() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of squared errors (SSE) associated with the regression model.
getSun() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.SolidTidesAcc
Get the Sun.
getSun() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Sun singleton body.
getSun() - Method in class org.orekit.propagation.events.NadirSolarIncidenceDetector
Returns Sun.
getSup() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Get the upper bound of the interval.
getSup() - Method in class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Get the highest value belonging to the instance.
getSupportedNames() - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Get the regular expression for supported files names.
getSupportedNames() - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Get the supported names for data files.
getSupportedNames() - Method in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Get the regular expression for supported files names.
getSupportedNames() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Get the regular expression for supported files names.
getSupportedNames() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Get the regular expression for supported files names.
getSupportedNames() - Method in class org.orekit.models.earth.GeoMagneticModelReader
Get the regular expression for supported files names.
getSupportedNames() - Method in interface org.orekit.time.UTCTAILoader
Get the regular expression for supported UTC-TAI offsets files names.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.FDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.TDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Access the lower bound of the support.
getSupportLowerBound() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Access the lower bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.FDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.TDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Access the upper bound of the support.
getSupportUpperBound() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Access the upper bound of the support.
getSurface() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
Get the surface
getSw(int) - Method in class org.orekit.forces.atmospheres.MSIS2000.Flags
Getter for a particular element in the sw array.
getSwc(int) - Method in class org.orekit.forces.atmospheres.MSIS2000.Flags
Getter for a particular element in the swc array.
getSwitches() - Method in class org.orekit.forces.atmospheres.MSIS2000.Flags
Getter for switches.
getT() - Method in class org.orekit.forces.atmospheres.DTM2000
Get the local temperature.
getT() - Method in class org.orekit.forces.atmospheres.MSIS2000.Output
Getter for temperature (t).
getT(int) - Method in class org.orekit.forces.atmospheres.MSIS2000.Output
Getter for temperature component.
getT0() - Method in class org.orekit.propagation.analytical.twod.DatePolynomialFunction
Returns the model origin date.
getT1() - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
 
getT2() - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
 
getTab() - Method in class org.apache.commons.math3.utils.AbstractSearchIndex
Returns the array of values.
getTab() - Method in interface org.apache.commons.math3.utils.ISearchIndex
Returns the array of values.
getTabDensity() - Method in class org.orekit.forces.atmospheres.HarrisPriester
Get the current density table.
getTAI() - Static method in class org.orekit.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.
getTarget() - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultivariateVectorOptimizer
Gets the observed values to be matched by the objective vector function.
getTarget() - Method in class org.apache.commons.math3.optim.nonlinear.vector.Target
Gets the initial guess.
getTarget() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Gets the observed values to be matched by the objective vector function.
getTarget() - Method in class org.apache.commons.math3.optimization.Target
Deprecated. Gets the initial guess.
getTarget() - Method in class org.orekit.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.
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.events.sensor.ExtremaSightAxisDetector
Get the target point.
getTargetPoint(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.BodyCenterGroundPointing
 
getTargetPoint(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.GroundPointing
Compute the target point in specified frame.
getTargetPoint(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.GroundPointingWrapper
Compute the target point in specified frame.
getTargetPoint(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.LofOffsetPointing
Compute the target point in specified frame.
getTargetPoint(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.NadirPointing
Compute the target point in specified frame.
getTargetPoint(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.TargetGroundPointing
Compute the target point in specified frame.
getTargetPV(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.GroundPointing
Compute the target point position/velocity in specified frame.
getTargetPV(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.GroundPointingWrapper
Compute the target point position/velocity in specified frame.
getTargetPV(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.NadirPointing
 
getTargetPVCoordinates(AbsoluteDate, Frame) - Method in class org.orekit.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 org.orekit.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 org.orekit.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 org.orekit.attitudes.directions.ToCelestialBodyCenterDirection
Provides the target point at a given date in a given frame, represented by the associated PVCoordinates object
getTargetRef() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. As of 3.1.
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 org.apache.commons.math3.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.
getTaskInfo() - Method in class fr.cnes.sirius.validate.parallel.AbstractSimpleParallelTaskImpl
 
getTaskInfo() - Method in interface fr.cnes.sirius.validate.parallel.ParallelTask
Returns human-readable info on the status of the task.
getTaskLabel() - Method in class fr.cnes.sirius.validate.parallel.AbstractSimpleParallelTaskImpl
 
getTaskLabel() - Method in interface fr.cnes.sirius.validate.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 org.orekit.time.TimeScalesFactory
Get the Barycentric Coordinate Time scale.
getTCG() - Static method in class org.orekit.time.TimeScalesFactory
Get the Geocentric Coordinate Time scale.
getTDB() - Static method in class org.orekit.time.TimeScalesFactory
Get the Barycentric Dynamic Time scale.
getTechnoLoss() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
 
getTEME() - Static method in class org.orekit.frames.FramesFactory
Get the TEME reference frame.
getTemp(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.US76
Get the local temperature for altitude in interval [0, 1E6] m
getTemperature() - Method in class org.orekit.propagation.events.ApparentElevationDetector
Get the local temperature at topocentric frame origin.
getTemporaryDirectory(String, String) - Static method in class fr.cnes.sirius.validate.files.TempDirectory
Static method to recover the temporary directory.
getThirdBody() - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Get 3rd body
getThirdBody() - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
Get 3rd body.
getThreeHourlyKP(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.DTM2000InputParameters
Get the value of the 3 hours geomagnetic index.
getThreeHourlyKP(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.DTM2000SolarData
Get the value of the 3 hours geomagnetic index.
getThreeHourlyKP(AbsoluteDate) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Get the value of the 3 hours geomagnetic index.
getThreshold() - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
getThreshold() - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
getThreshold() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
 
getThreshold(int) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ComparisonData
Gets the threshold related to a column.
getThreshold() - Method in exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
 
getThreshold() - Method in exception org.apache.commons.math3.linear.NonSymmetricMatrixException
 
getThreshold() - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Get the convergence threshold in the event time search.
getThreshold() - Method in class org.orekit.propagation.events.AbstractDetector
Get the convergence threshold in the event time search.
getThreshold() - Method in interface org.orekit.propagation.events.EventDetector
Get the convergence threshold in the event time search.
getThreshold() - Method in interface org.orekit.propagation.events.multi.MultiEventDetector
Get the convergence threshold in the event time search.
getThreshold() - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Get the convergence threshold in the event time search.
getThresholds() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
get the thresholds of the columns.
getThresholdsData() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
 
getThrowable() - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Get a reference to the exception to which the context relates.
getThrust(SpacecraftState) - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Get the thrust.
getTidalCorrectionModel() - Method in class org.orekit.frames.configuration.DiurnalRotation
 
getTidalCorrectionModel() - Method in class org.orekit.frames.configuration.PolarMotion
 
getTiesStrategy() - Method in class org.apache.commons.math3.stat.ranking.NaturalRanking
Return the TiesStrategy
getTime() - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Get current time.
getTime() - Method in class org.orekit.propagation.events.LocalTimeDetector
Get local time to detect.
getTime() - Method in class org.orekit.propagation.events.SolarTimeDetector
Get solar time to detect.
getTime() - Method in class org.orekit.time.DateTimeComponents
Get the time component.
getTimeDerivativesList() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Returns time derivatives list.
getTimeInterval() - Method in class fr.cnes.sirius.patrius.guidance.GuidanceProfile
 
getTimeInterval() - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialSegment
Get the time interval of the guidance profile segment.
getTimeInterval() - Method in class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
Get the time interval of the guidance profile segment.
getTimeInterval() - Method in class org.orekit.attitudes.AbstractSlew
 
getTimeInterval() - Method in class org.orekit.attitudes.AttitudeLawLeg
 
getTimeInterval() - Method in interface org.orekit.attitudes.AttitudeLeg
Return the time interval of validity
getTimeInterval() - Method in class org.orekit.attitudes.AttitudeLegsSequence
 
getTimeInterval() - Method in class org.orekit.attitudes.RelativeTabulatedAttitudeLeg
 
getTimeInterval() - Method in class org.orekit.attitudes.TabulatedAttitude
Return the time interval of validity
getTimeIntervalOfValidity() - Method in interface org.orekit.frames.configuration.FramesConfiguration
Time interval of validity for the EOP files.
getTimeIntervalOfValidity() - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Get the time interval of validity.
getTimespan() - Method in class fr.cnes.sirius.patrius.events.Phenomenon
Get the timespan as an AbsoluteDateInterval.
getTimeSystem() - Method in interface org.orekit.files.general.OrbitFile
Returns the OrbitFile.TimeSystem used to time-stamp position entries.
getTimeSystem() - Method in class org.orekit.files.sp3.SP3File
Returns the OrbitFile.TimeSystem used to time-stamp position entries.
getTinf() - Method in class org.orekit.forces.atmospheres.DTM2000
Get the current exospheric temperature above input position.
getTIRF() - Static method in class org.orekit.frames.FramesFactory
Get the TIRF reference frame.
getTLE() - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Get the fitted Two-Lines Elements.
getTLE(double[]) - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Get the TLE for a given position/velocity/B* parameters set.
getTLE() - Method in class org.orekit.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 org.orekit.frames.FramesFactory
Get the TOD reference frame.
getTopocentricFrame() - Method in class org.orekit.propagation.events.ApparentElevationDetector
Get the topocentric frame.
getTopocentricFrame() - Method in class org.orekit.propagation.events.ElevationDetector
Get the topocentric frame.
getTopocentricFrame() - Method in class org.orekit.propagation.events.ExtremaElevationDetector
 
getTopocentricFrame() - Method in class org.orekit.propagation.events.GroundMaskElevationDetector
Get the topocentric frame.
getTopocentricPosition() - Method in class org.orekit.utils.TopocentricPV
Get the Topocentric position.
getTopoFrame() - Method in class fr.cnes.sirius.patrius.groundstation.GeometricStationAntenna
 
getTorque() - Method in class org.orekit.wrenches.Wrench
 
getTorque(Vector3D) - Method in class org.orekit.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 org.apache.commons.math3.ode.ExpandableStatefulODE
Return the dimension of the complete set of equations.
getTotalIntensity() - Method in class org.orekit.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() - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
Return the mass of the spacecraft.
getTotalMass() - Method in class fr.cnes.sirius.patrius.assembly.models.MassModel
Return the mass of the spacecraft.
getTotalMass() - Method in interface org.orekit.propagation.MassProvider
Return the mass of the spacecraft.
getTotalMass() - Method in class org.orekit.propagation.SimpleMassModel
Return the mass of the spacecraft.
getTotalSumSquares() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns the sum of squared deviations of the y values about their mean.
getTotalSumSquares() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of squared deviations of the y values about their mean.
getTrace() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTransform(AffineTransform) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get a Transform embedding an affine transform.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.attitudes.AttitudeTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.attitudes.AttitudeTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.attitudes.AttitudeTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.attitudes.AttitudeTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.attitudes.OrientationTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.attitudes.OrientationTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.attitudes.OrientationTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.attitudes.OrientationTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.CIRFProvider
Get the transform from GCRF to CIRF2000 at the specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.CIRFProvider
Get the transform from GCRF to CIRF2000 at the specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.CIRFProvider
Get the transform from GCRF to CIRF2000 at the specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.CIRFProvider
Get the transform from GCRF to CIRF2000 at the specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.EODProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.EODProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.EODProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.EODProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.FixedTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.FixedTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.FixedTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.FixedTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.GTODProvider
Get the transform from TOD at specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.GTODProvider
Get the transform from TOD at specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.GTODProvider
Get the transform from TOD at specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.GTODProvider
Get the transform from TOD at specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.HelmertTransformation
Compute the transform at some date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.HelmertTransformation
Compute the transform at some date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.HelmertTransformation
Compute the transform at some date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.HelmertTransformation
Compute the transform at some date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.InterpolatingTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.InterpolatingTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.InterpolatingTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.InterpolatingTransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.ITRFEquinoxProvider
Get the transform from GTOD at specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.ITRFEquinoxProvider
Get the transform from GTOD at specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.ITRFEquinoxProvider
Get the transform from GTOD at specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.ITRFEquinoxProvider
Get the transform from GTOD at specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.ITRFProvider
Get the transform from TIRF 2000 at specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.ITRFProvider
Get the transform from TIRF 2000 at specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.ITRFProvider
Get the transform from TIRF 2000 at specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.ITRFProvider
Get the transform from TIRF 2000 at specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.MODProvider
Get the transfrom from parent frame.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.MODProvider
Get the transfrom from parent frame.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.MODProvider
Get the transfrom from parent frame.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.MODProvider
Get the transfrom from parent frame.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.TEMEProvider
Get the transform from True Of Date date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.TEMEProvider
Get the transform from True Of Date date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.TEMEProvider
Get the transform from True Of Date date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.TEMEProvider
Get the transform from True Of Date date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.TIRFProvider
Get the transform from CIRF 2000 at specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.TIRFProvider
Get the transform from CIRF 2000 at specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.TIRFProvider
Get the transform from CIRF 2000 at specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.TIRFProvider
Get the transform from CIRF 2000 at specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.TODProvider
Get the transform from Mean Of Date at specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.TODProvider
Get the transform from Mean Of Date at specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.TODProvider
Get the transform from Mean Of Date at specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.TODProvider
Get the transform from Mean Of Date at specified date.
getTransform(AbsoluteDate) - Method in interface org.orekit.frames.transformations.TransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in interface org.orekit.frames.transformations.TransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, boolean) - Method in interface org.orekit.frames.transformations.TransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in interface org.orekit.frames.transformations.TransformProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate) - Method in class org.orekit.frames.transformations.VEISProvider
Get the transform from GTOD at specified date.
getTransform(AbsoluteDate, boolean) - Method in class org.orekit.frames.transformations.VEISProvider
Get the transform from GTOD at specified date.
getTransform(AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.transformations.VEISProvider
Get the Transform corresponding to specified date.
getTransform(AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.transformations.VEISProvider
Get the Transform corresponding to specified date.
getTransformer(Class<?>) - Method in class org.apache.commons.math3.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 org.orekit.frames.Frame
Compute the Jacobian from current frame to target frame at provided date.
getTransformProvider() - Method in class org.orekit.frames.Frame
Get the provider for transform from parent frame to instance.
getTransformTo(Frame, AbsoluteDate) - Method in class org.orekit.frames.Frame
Get the transform from the instance to another frame.
getTransformTo(Frame, AbsoluteDate, boolean) - Method in class org.orekit.frames.Frame
Get the transform from the instance to another frame.
getTransformTo(Frame, AbsoluteDate, FramesConfiguration) - Method in class org.orekit.frames.Frame
Get the transform from the instance to another frame.
getTransformTo(Frame, AbsoluteDate, FramesConfiguration, boolean) - Method in class org.orekit.frames.Frame
Get the transform from the instance to another frame.
getTranslation() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Screw
 
getTranslation() - Method in class org.orekit.frames.transformations.Transform
Get the position of the "destination" frame in the "origin" one.
getTransverseRadius() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Spheroid
Get transverse radius of Spheroid
getTransverseRadius() - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
Return transverse radius (major semi axis)
getTree(boolean) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the underlying BSP tree.
getTree(boolean) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the underlying BSP tree.
gettRef() - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
 
getTrigger() - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Get the triggering event.
getTrigonometricCoefficients() - Method in class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Returns the trigonometric coefficients array.
getTrigonometricPolynomial() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get the Trigonometric Polynomial Part
getTrigonometricValue(double, double) - Method in class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Get the value of the trigonometric contribution with maximum order.
getTrigonometricValue(double, double, int) - Method in class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Get the value of the trigonometric contribution up to provided order.
getTrueAnomaly() - Method in class org.orekit.orbits.EquatorialOrbit
Get the true anomaly.
getTrueAnomaly() - Method in class org.orekit.orbits.KeplerianOrbit
Get the true anomaly.
getTrueAnomaly() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Get the true anomaly.
getTrueAnomaly() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Get the true anomaly.
getTT() - Static method in class org.orekit.time.TimeScalesFactory
Get the Terrestrial Time scale.
getTwo() - Method in class org.apache.commons.math3.dfp.Dfp
Get the constant 2.
getTwo() - Method in class org.apache.commons.math3.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.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.AeroFacetProperty
 
getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
 
getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
 
getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.CrossSectionProviderProperty
 
getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.GeometricProperty
 
getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.MassProperty
 
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.RadiativeFacetProperty
 
getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
 
getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
 
getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RadiativeSphereProperty
 
getType() - Method in class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
 
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.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.
getType() - Method in class org.orekit.files.sp3.SP3File
Returns the SP3File.SP3FileType associated with this SP3 file.
getType() - Method in class org.orekit.orbits.ApsisOrbit
Get the orbit type.
getType() - Method in class org.orekit.orbits.CartesianOrbit
Get the orbit type.
getType() - Method in class org.orekit.orbits.CircularOrbit
Get the orbit type.
getType() - Method in class org.orekit.orbits.EquatorialOrbit
Get the orbit type.
getType() - Method in class org.orekit.orbits.EquinoctialOrbit
Get the orbit type.
getType() - Method in class org.orekit.orbits.KeplerianOrbit
Get the orbit type.
getType() - Method in class org.orekit.orbits.Orbit
Get the orbit type.
getU() - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
Get the U axis
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
 
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
 
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
 
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
 
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
 
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
 
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the plane first canonical vector.
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getU() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
 
getU() - Method in class org.apache.commons.math3.linear.FieldLUDecomposition
Returns the matrix U of the decomposition.
getU() - Method in class org.apache.commons.math3.linear.LUDecomposition
Returns the matrix U of the decomposition.
getU() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the matrix U of the decomposition.
getU() - Method in interface org.apache.commons.math3.linear.UDDecomposition
Returns the matrix U of the decomposition.
getU() - Method in class org.apache.commons.math3.linear.UDDecompositionImpl
get the U matrix
getUnderlyingAttitudeLaw() - Method in interface org.orekit.attitudes.AttitudeLawModifier
Get the underlying attitude law.
getUnderlyingAttitudeLaw() - Method in class org.orekit.attitudes.ComposedAttitudeLaw
 
getUnderlyingAttitudeLaw() - Method in class org.orekit.attitudes.GroundPointingWrapper
Get the underlying (ground pointing) attitude provider.
getUnderlyingAttitudeLaw() - Method in class org.orekit.attitudes.SpinStabilized
Get the underlying attitude law.
getUniqueCount() - Method in class org.apache.commons.math3.stat.Frequency
Returns the number of values in the frequency table.
getUpper() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Interval
Deprecated. as of 3.1, replaced by Interval.getSup()
getUpper() - Method in class org.apache.commons.math3.optim.SimpleBounds
Gets the upper bounds.
getUpper() - Method in class org.apache.commons.math3.optimization.SimpleBounds
Deprecated. Gets the lower bounds.
getUpperAngle() - Method in class fr.cnes.sirius.patrius.utils.AngleInterval
 
getUpperBound() - Method in class org.apache.commons.math3.optim.BaseMultivariateOptimizer
 
getUpperBound() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated.  
getUpperBound() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
Deprecated.  
getUpperBounds() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Returns a fresh copy of the array of upper bounds for the bins.
getUpperCaseAbbreviation() - Method in enum org.orekit.time.Month
Get the upper case three letters abbreviation.
getUpperCaseName() - Method in enum org.orekit.time.Month
Get the upper case full name.
getUpperData() - Method in class fr.cnes.sirius.patrius.utils.GenericInterval
 
getUpperData() - Method in class org.orekit.utils.GenericInterval
 
getUpperEndPoint() - Method in class fr.cnes.sirius.patrius.utils.AbstractInterval
 
getUpperEndpoint() - Method in class org.orekit.utils.GenericInterval
 
getUranus() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Uranus singleton body.
getUT() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the transpose of the matrix U of the decomposition.
getUT() - Method in interface org.apache.commons.math3.linear.UDDecomposition
Returns the transpose of the matrix U of the decomposition.
getUT() - Method in class org.apache.commons.math3.linear.UDDecompositionImpl
get the UT matrix
getUT1() - Static method in class org.orekit.time.TimeScalesFactory
Get the Universal Time 1 scale.
getUT1Correction(AbsoluteDate) - Method in class org.orekit.frames.configuration.DiurnalRotation
Compute ut1-tai correction.
getUT1Correction(AbsoluteDate) - Method in interface org.orekit.frames.configuration.FramesConfiguration
Compute correction dut1.
getUT1Correction(AbsoluteDate) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Compute correction dut1.
getUT1Correction(AbsoluteDate) - Method in class org.orekit.frames.configuration.libration.IERS2010LibrationCorrection
Get the dUT1 value.
getUT1Correction(AbsoluteDate) - Method in interface org.orekit.frames.configuration.libration.LibrationCorrectionModel
Compute the UT1-TAI corrections at a given date.
getUT1Correction(AbsoluteDate) - Method in class org.orekit.frames.configuration.libration.NoLibrationCorrection
Compute the UT1-TAI corrections at a given date.
getUT1Correction(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.IERS2003TidalCorrection
Compute the UT1-TAI corrections at a given date.
getUT1Correction(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.IERS2010TidalCorrection
Compute the UT1-TAI corrections at a given date.
getUT1Correction(AbsoluteDate) - Method in class org.orekit.frames.configuration.tides.NoTidalCorrection
Compute the UT1-TAI corrections at a given date.
getUT1Correction() - Method in class org.orekit.frames.configuration.tides.TidalCorrection
 
getUT1Correction(AbsoluteDate) - Method in interface org.orekit.frames.configuration.tides.TidalCorrectionModel
Compute the UT1-TAI corrections at a given date.
getUT1MinusTAI(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Get the UT1-TAI value.
getUT1MinusTAI(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
Get the UT1-TAI value.
getUT1MinusTAI() - Method in class org.orekit.frames.configuration.eop.EOPEntry
Get the UT1-TAI value.
getUT1MinusTAI(AbsoluteDate) - Method in interface org.orekit.frames.configuration.eop.EOPHistory
Get the UT1-TAI value.
getUT1MinusTAI(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.NoEOP2000History
getUT1MinusTAI.
getUT1MinusTAI(AbsoluteDate) - Method in interface org.orekit.frames.configuration.FramesConfiguration
Compute corrected ut1-tai.
getUT1MinusTAI(AbsoluteDate) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Compute corrected ut1-tai.
getUT1MinusUTC(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Get the UT1-UTC value.
getUT1MinusUTC(AbsoluteDate) - Method in class org.orekit.frames.configuration.eop.EOP2000HistoryConstantOutsideInterval
Get the UT1-UTC value.
getUT1MinusUTC(AbsoluteDate) - Method in interface org.orekit.frames.configuration.eop.EOPHistory
Get the UT1-UTC value.
getUTC() - Static method in class org.orekit.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 org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
 
getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
 
getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
 
getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
 
getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
 
getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
 
getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the plane second canonical vector.
getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getV() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
 
getV() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets the matrix V of the decomposition.
getV() - Method in class org.apache.commons.math3.linear.SingularValueDecomposition
Returns the matrix V of the decomposition.
getValidityDuration() - Method in class org.orekit.bodies.PosVelChebyshev
Get model validity duration.
getValue() - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.DoubleDPFacade
 
getValue() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the value part of the derivative structure.
getValue(String) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Gets the value associated to the given context key.
getValue() - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapEntry
Deprecated. Get the value of the entry.
getValue() - Method in class org.apache.commons.math3.linear.RealVector.Entry
Get the value of the entry.
getValue() - Method in class org.apache.commons.math3.optim.linear.LinearConstraint
Gets the value of the constraint (right hand side).
getValue() - Method in class org.apache.commons.math3.optim.PointVectorValuePair
Gets the value of the objective function.
getValue() - Method in class org.apache.commons.math3.optim.univariate.UnivariatePointValuePair
Get the value of the objective function.
getValue() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated. Get the value of the constraint (right hand side).
getValue(double[]) - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated. Compute the value of the linear equation at the current point
getValue(RealVector) - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated. Compute the value of the linear equation at the current point
getValue() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated. Gets the value of the objective function.
getValue() - Method in class org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair
Deprecated. Get the value of the objective function.
getValue() - Method in class org.apache.commons.math3.util.Pair
Get the value.
getValue() - Method in class org.orekit.parameter.Parameter
Getting parameter value.
getValue(AbsoluteDate, double, double) - Method in class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Get the value of the model at provided date.
getValue(AbsoluteDate, double, double, int) - Method in class org.orekit.propagation.analytical.twod.Analytical2DParameterModel
Get the value of the model at provided date.
getValueRef() - Method in class org.apache.commons.math3.optim.PointVectorValuePair
Gets a reference to the value of the objective function.
getValueRef() - Method in class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated. Gets a reference to the value of the objective function.
getValues() - Method in class org.apache.commons.math3.analysis.interpolation.BiLinearIntervalsFunction
Gets ftab in dimension 2
getValues() - Method in class org.apache.commons.math3.analysis.interpolation.TriLinearIntervalsFunction
Gets ftab in dimension 3
getValues() - Method in class org.apache.commons.math3.analysis.interpolation.UniLinearIntervalsFunction
Getter for ftab in dimension 1
getValues() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives.
getValues() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the current set of values in an array of double primitives.
getValuesFileURL() - Method in class org.apache.commons.math3.random.ValueServer
Returns the URL for the file used to build the empirical distribution when using ValueServer.DIGEST_MODE.
getValuesSamples() - Method in class org.orekit.utils.InterpolationTableLoader
Returns a copy of the values samples for the interpolation function.
getVariablePotentialProvider() - Static method in class org.orekit.forces.gravity.variations.coefficients.VariableGravityFieldFactory
Get the variable gravity field coefficients provider from the first supported file.
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.AggregateSummaryStatistics
Returns the variance of the available values.
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the (sample) variance of the available values.
getVariance() - Method in interface org.apache.commons.math3.stat.descriptive.StatisticalSummary
Returns the variance of the available values.
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
 
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the (sample) variance of the available values.
getVariance() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the (sample) variance of the available values.
getVarianceDirection() - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns the varianceDirection property.
getVarianceImpl() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Returns the currently configured variance implementation.
getVarianceImpl() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns the currently configured variance implementation
getVarianceImpl() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured variance implementation
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.SignalPropagation
 
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.CelestialBodyPolesAxisDirection
Provides the direction vector at a given date in a given frame.
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.ConstantVectorDirection
Provides the direction vector at a given date in a given frame.
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.CrossProductDirection
Provides the cross product of direction1 vector and dirction2 vector.
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.EarthCenterDirection
Provides the direction vector at a given date in a given frame.
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.GenericTargetDirection
Provides the direction vector at a given date in a given frame.
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.GlintApproximatePointingDirection
Provides the direction vector at a given date in a given frame.
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.GroundVelocityDirection
 
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in interface org.orekit.attitudes.directions.IDirection
Provides the direction vector at a given date in a given frame.
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.MomentumDirection
Provides the direction vector at a given date in a given frame.
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.NadirDirection
 
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.ToCelestialBodyCenterDirection
Provides the direction vector at a given date in a given frame.
getVector(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.directions.VelocityDirection
Provides the direction vector at a given date in a given frame.
getVector3D(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
Get the angular velocity from the vector 3D polynomials at a given date.
getVector3D(AbsoluteDate) - Method in class org.orekit.attitudes.kinematics.AbstractVector3DFunction
Get the vector at a given date.
getVector3D(AbsoluteDate) - Method in interface org.orekit.attitudes.kinematics.Vector3DFunction
Get the vector at a given date.
getVectorFunction() - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesPolynomialProfile
 
getVectorialLocalExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Express a Vector3D in ellipsoid local basis.
getVectorialLocalExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Express a Vector3D in spheroid local frame.
getVectorialLocalExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
Express a Vector3D in spheroid local frame.
getVectorialStandardExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Express a Vector3D in standard basis.
getVectorialStandardExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Express a Vector3D in standard basis.
getVectorialStandardExpression(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
Express a Vector3D in standard basis.
getVectorPart() - Method in class org.apache.commons.math3.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.sensor.ExtremaSightAxisDetector
Get the vehicle.
getVeis1950() - Static method in class org.orekit.frames.FramesFactory
Get the VEIS 1950 reference frame.
getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.stela.forces.atmospheres.MSIS00Adapter
 
getVelocity(AbsoluteDate, Vector3D, Frame) - Method in interface org.orekit.forces.atmospheres.Atmosphere
Get the spacecraft velocity relative to the atmosphere.
getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.DTM2000
Get the inertial velocity of atmosphere molecules.
getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.HarrisPriester
Get the inertial velocity of atmosphere molecules.
getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.JB2006
Get the inertial velocity of atmosphere molecules.
getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.MSISE2000
Get the spacecraft velocity relative to the atmosphere.
getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.SimpleExponentialAtmosphere
Get the spacecraft velocity relative to the atmosphere.
getVelocity(AbsoluteDate, Vector3D, Frame) - Method in class org.orekit.forces.atmospheres.US76
Get the spacecraft velocity relative to the atmosphere.
getVelocity() - Method in class org.orekit.frames.transformations.Transform
Get the velocity of the "destination" frame in the "origin" one.
getVelocity() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Get the velocity.
getVelocity() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Getter for velocity.
getVelocity() - Method in class org.orekit.utils.CardanMountPV
 
getVelocity() - Method in interface org.orekit.utils.PV
Gets the velocity.
getVelocity() - Method in class org.orekit.utils.PVCoordinates
Gets the velocity.
getVelocity() - Method in class org.orekit.utils.TopocentricPV
 
getVenus() - Static method in class org.orekit.bodies.CelestialBodyFactory
Get the Venus singleton body.
getVertices() - Method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Get the vertices of the polygon.
getVT() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Gets the transpose of the matrix V of the decomposition.
getVT() - Method in class org.apache.commons.math3.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.utils.AlmanacParameter
 
getW() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
 
getWeekRef() - Method in class fr.cnes.sirius.patrius.utils.AlmanacParameter
 
getWeight() - Method in class org.apache.commons.math3.fitting.WeightedObservedPoint
Gets the weight of the measurement in the fitting process.
getWeight() - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultivariateVectorOptimizer
Gets the weight matrix of the observations.
getWeight() - Method in class org.apache.commons.math3.optim.nonlinear.vector.Weight
Gets the initial guess.
getWeight() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Gets the weight matrix of the observations.
getWeight() - Method in class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
Deprecated. Get the weight of the measurement in the fitting process.
getWeight() - Method in class org.apache.commons.math3.optimization.Weight
Deprecated. Gets the initial guess.
getWeight() - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Get the weights for residuals.
getWeightRef() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. As of 3.1.
getWeightSquareRoot() - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Gets the square-root of the weight matrix.
getWeightSquareRoot() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. Gets the square-root of the weight matrix.
getWest() - Method in class org.orekit.bodies.GeodeticPoint
Get the direction to the west of point, expressed in parent shape frame.
getWest() - Method in class org.orekit.frames.TopocentricFrame
Get the west direction of topocentric frame, expressed in parent shape frame.
getWholeFormat() - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
Access the whole format.
getWholeFormat() - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
Access the whole format.
getWidth() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
 
getWidth() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
 
getWidth() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
 
getWidth() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
 
getWindowSize() - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.orekit.models.earth.GeoMagneticFieldFactory
Get the WMM model for the given year.
getWMM(double) - Static method in class org.orekit.models.earth.GeoMagneticFieldFactory
Get the WMM model for the given year.
getWrench() - Method in class org.orekit.wrenches.Wrench
Get a double[] representation of this wrench.
getWrongColumnDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
 
getWrongDimension(int) - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
 
getWrongDimensions() - Method in exception org.apache.commons.math3.exception.MultiDimensionMismatchException
 
getWrongRowDimension() - Method in exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
 
getX() - Method in class org.apache.commons.math3.fitting.WeightedObservedPoint
Gets the abscissa of the point.
getX() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the abscissa of the vector.
getX() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the abscissa of the vector.
getX() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the abscissa of the vector.
getX() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the abscissa of the vector.
getX() - Method in class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
Deprecated. Get the abscissa of the point.
getX() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
 
getX() - Method in class org.orekit.frames.configuration.eop.EOPEntry
Get the X component of the pole motion.
getX() - Method in class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
 
getX0() - Method in class org.orekit.propagation.analytical.twod.DateIntervalLinearFunction
Returns value at first date.
getX0() - Method in class org.orekit.propagation.analytical.twod.DateIntervalParabolicFunction
Returns value at first date.
getXangle() - Method in class org.orekit.utils.CardanMountPosition
Get the x angle.
getXangle() - Method in class org.orekit.utils.CardanMountPV
Get the angle of the rotation around the local North axis.
getXangleCardan(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the Cardan x angle of a point.
getXangleCardanRate(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the Cardan x angle rate.
getXangleRate() - Method in class org.orekit.utils.CardanMountPV
Get the angle rate of the rotation around the North axis.
getXCoefficients() - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesPolynomialProfile
 
getXCoefficients() - Method in class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
 
getxDot0() - Method in class org.orekit.propagation.analytical.twod.DateIntervalParabolicFunction
Returns first derivative value at first date.
getxDotDotIntervals() - Method in class org.orekit.propagation.analytical.twod.DateIntervalParabolicFunction
Returns a copy of 1st order derivatives on date intervals.
getxDotIntervals() - Method in class org.orekit.propagation.analytical.twod.DateIntervalLinearFunction
Returns a copy of 1st order derivatives on date intervals.
getXM10(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.JB2006InputParameters
Get the MG2 index scaled to F10.
getXM10B(AbsoluteDate) - Method in interface org.orekit.forces.atmospheres.JB2006InputParameters
Get the MG2 81-day average centered index.
getXp() - Method in class org.orekit.frames.configuration.eop.PoleCorrection
Get the xp parameter.
getxP() - Method in class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
 
getXSumSquares() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the sum of squared deviations of the x values about their mean.
getxtab() - Method in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Gets xtab
getY() - Method in class org.apache.commons.math3.fitting.WeightedObservedPoint
Gets the observed value of the function at x.
getY() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the ordinate of the vector.
getY() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the ordinate of the vector.
getY() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the ordinate of the vector.
getY() - Method in class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
Deprecated. Get the observed value of the function at x.
getY() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
 
getY() - Method in class org.orekit.frames.configuration.eop.EOPEntry
Get the Y component of the pole motion.
getY() - Method in class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
 
getYangle() - Method in class org.orekit.utils.CardanMountPosition
Get the y angle.
getYangle() - Method in class org.orekit.utils.CardanMountPV
Get the angle of the rotation around y' axis.
getYangleCardan(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the Cardan y angle of a point with regards to the projection point on the plane defined by the zenith and the west axis.
getYangleCardanRate(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Get the Cardan y angle rate.
getYangleRate() - Method in class org.orekit.utils.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).
getYawAngle(PVCoordinatesProvider, AbsoluteDate, Frame) - Method in class org.orekit.attitudes.YawCompensation
Compute the yaw compensation angle at date.
getYCoefficients() - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesPolynomialProfile
 
getYCoefficients() - Method in class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
 
getYear() - Method in class org.orekit.time.DateComponents
Get the year number.
getYp() - Method in class org.orekit.frames.configuration.eop.PoleCorrection
Get the yp parameter.
getyP() - Method in class org.orekit.frames.configuration.precessionnutation.CIPCoordinates
 
getytab() - Method in class org.apache.commons.math3.analysis.interpolation.BiLinearIntervalsFunction
Gets ytab
getytab() - Method in class org.apache.commons.math3.analysis.interpolation.TriLinearIntervalsFunction
Gets ytab
getZ() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the height of the vector.
getZ() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the height of the vector.
getZCoefficients() - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesPolynomialProfile
 
getZCoefficients() - Method in class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
 
getZenith() - Method in class org.orekit.bodies.GeodeticPoint
Get the direction above the point, expressed in parent shape frame.
getZenith() - Method in class org.orekit.frames.TopocentricFrame
Get the zenith direction of topocentric frame, expressed in parent shape frame.
getZero() - Method in class org.apache.commons.math3.complex.ComplexField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.dfp.Dfp
Get the constant 0.
getZero() - Method in class org.apache.commons.math3.dfp.DfpField
Get the constant 0.
getZero() - Method in interface org.apache.commons.math3.Field
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.fraction.BigFractionField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.fraction.FractionField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - Method in interface org.apache.commons.math3.geometry.Vector
Get the null vector of the vectorial space or origin point of the affine space.
getZero() - Method in class org.apache.commons.math3.util.BigRealField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math3.util.Decimal64Field
Get the additive identity of the field.
getZeroDate() - Method in class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Get the date at x = 0.
getZeroDate() - Method in class org.orekit.attitudes.kinematics.AbstractVector3DFunction
Get the date at x = 0.
getztab() - Method in class org.apache.commons.math3.analysis.interpolation.TriLinearIntervalsFunction
Gets ztab
GillIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the Gill fourth order Runge-Kutta integrator for Ordinary Differential Equations .
GillIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.GillIntegrator
Simple constructor.
GlintApproximatePointingDirection - Class in org.orekit.attitudes.directions
"Glint" direction pointing.
GlintApproximatePointingDirection(ExtendedOneAxisEllipsoid, PVCoordinatesProvider, UnivariateSolver) - Constructor for class org.orekit.attitudes.directions.GlintApproximatePointingDirection
Constructor.
GlintApproximatePointingDirection(ExtendedOneAxisEllipsoid, PVCoordinatesProvider) - Constructor for class org.orekit.attitudes.directions.GlintApproximatePointingDirection
Constructor with default solver (BisectionSolver.BisectionSolver(double, double)).
GLSMultipleLinearRegression - Class in org.apache.commons.math3.stat.regression
The GLS implementation of the multiple linear regression.
GLSMultipleLinearRegression() - Constructor for class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
 
GMSTScale - Class in org.orekit.time
Greenwich Mean Sidereal Time.
goAhead(double, double, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
go one step ahead
GoalType - Enum in org.apache.commons.math3.optim.nonlinear.scalar
Goal type for an optimization problem (minimization or maximization of a scalar function.
GoalType - Enum in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
GPS_EPOCH - Static variable in class org.orekit.time.AbsoluteDate
Reference epoch for GPS weeks: 1980-01-06T00:00:00 GPS time.
GPS_EPOCH - Static variable in class org.orekit.time.DateComponents
Reference epoch for GPS weeks: 1980-01-06.
GPSAlmanacParameters - Class in fr.cnes.sirius.patrius.utils
This class is a simple container for GPS almanac parameters.
GPSAlmanacParameters(double, int, double, double, double, double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.utils.GPSAlmanacParameters
Creates an instance of GPS Almanac parameters.
GPSScale - Class in org.orekit.time
GPS time scale.
gradient() - Method in interface org.apache.commons.math3.analysis.DifferentiableMultivariateFunction
Deprecated. Returns the gradient function.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Gaussian.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logistic.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logit.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.function.Sigmoid.Parametric
Computes the value of the gradient at x.
gradient(double, double...) - Method in interface org.apache.commons.math3.analysis.ParametricUnivariateFunction
Compute the gradient of the function with respect to its parameters.
gradient(double, double...) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric
Compute the gradient of the function with respect to its parameters.
GradientFunction - Class in org.apache.commons.math3.analysis.differentiation
Class representing the gradient of a multivariate function.
GradientFunction(MultivariateDifferentiableFunction) - Constructor for class org.apache.commons.math3.analysis.differentiation.GradientFunction
Simple constructor.
GradientModel - Interface in org.orekit.forces
Interface for gradient model.
GradientMultivariateOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar
Base class for implementing optimizers for multivariate scalar differentiable functions.
GradientMultivariateOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.GradientMultivariateOptimizer
 
GraggBulirschStoerIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements a Gragg-Bulirsch-Stoer integrator for Ordinary Differential Equations.
GraggBulirschStoerIntegrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Simple constructor.
GraggBulirschStoerIntegrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Simple constructor.
GRAVITATIONAL_CONSTANT - Static variable in interface org.orekit.utils.CnesConstants
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
GravityFieldFactory - Class in org.orekit.forces.gravity.potential
Factory used to read gravity field files in several supported formats.
GravityToolbox - Class in org.orekit.forces.gravity
Toolbox for tides.
greaterOrEqual(double, double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Tests if one angle is greater or equal to another after expressing them in the same interval.
greaterOrEqual(double, double) - Static method in class fr.cnes.sirius.patrius.utils.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.utils.Comparators
Tests if a double is greater or equal to another with a relative comparison using an input epsilon.
greaterStrict(double, double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Tests if one angle is strictly greater than another after expressing them in the same interval.
greaterStrict(double, double) - Static method in class fr.cnes.sirius.patrius.utils.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.utils.Comparators
Tests if a double is strictly greater than another with a relative comparison using an input epsilon.
greaterThan(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is greater than x.
GRGS_FILENAME - Static variable in class org.orekit.forces.gravity.potential.GravityFieldFactory
Default regular expression for GRGS files.
GRGSFormatReader - Class in org.orekit.forces.gravity.potential
Reader for the GRGS gravity field format.
GRGSFormatReader(String, boolean) - Constructor for class org.orekit.forces.gravity.potential.GRGSFormatReader
Simple constructor.
GRGSRL02_FILENAME - Static variable in class org.orekit.forces.gravity.variations.coefficients.VariableGravityFieldFactory
EIGEN GRGS default filename
GRGSRL02FormatReader - Class in org.orekit.forces.gravity.variations.coefficients
Reader for the GRGS RL02 gravity field format.
GRGSRL02FormatReader(String) - Constructor for class org.orekit.forces.gravity.variations.coefficients.GRGSRL02FormatReader
Simple constructor.
GRIM5C1_EARTH_ANGULAR_VELOCITY - Static variable in interface org.orekit.utils.Constants
Earth angular velocity from GRIM5C1 model: 7.292115e-5 rad/s.
GRIM5C1_EARTH_C20 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized second zonal coefficient from GRIM5C1 model: -1.082626110612609e-3.
GRIM5C1_EARTH_C30 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized third zonal coefficient from GRIM5C1 model: 2.536150841690056e-6.
GRIM5C1_EARTH_C40 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized fourth zonal coefficient from GRIM5C1 model: 1.61936352497151e-6.
GRIM5C1_EARTH_C50 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized fifth zonal coefficient from GRIM5C1 model: 2.231013736607540e-7.
GRIM5C1_EARTH_C60 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized sixth zonal coefficient from GRIM5C1 model: -5.402895357302363e-7.
GRIM5C1_EARTH_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.Constants
Earth equatorial radius from GRIM5C1 model: 6378136.46 m.
GRIM5C1_EARTH_FLATTENING - Static variable in interface org.orekit.utils.Constants
Earth flattening from GRIM5C1 model: 1.0 / 298.25765.
GRIM5C1_EARTH_MU - Static variable in interface org.orekit.utils.Constants
Earth gravitational constant from GRIM5C1 model: 3.986004415 m3/s2.
GroundMaskElevationDetector - Class in org.orekit.propagation.events
Finder for satellite azimuth-elevation events with respect to a mask.
GroundMaskElevationDetector(double[][], TopocentricFrame) - Constructor for class org.orekit.propagation.events.GroundMaskElevationDetector
Build a new azimuth-elevation detector.
GroundMaskElevationDetector(double[][], TopocentricFrame, double) - Constructor for class org.orekit.propagation.events.GroundMaskElevationDetector
Build a new azimuth-elevation detector.
GroundMaskElevationDetector(double[][], TopocentricFrame, double, double) - Constructor for class org.orekit.propagation.events.GroundMaskElevationDetector
Build a new azimuth-elevation detector.
GroundMaskElevationDetector(double[][], TopocentricFrame, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.GroundMaskElevationDetector
Build a new azimuth-elevation detector.
GroundMaskElevationDetector(double[][], TopocentricFrame, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.GroundMaskElevationDetector
Build a new azimuth-elevation detector.
GroundPointing - Class in org.orekit.attitudes
Base class for ground pointing attitude providers.
GroundPointing(BodyShape) - Constructor for class org.orekit.attitudes.GroundPointing
Default constructor.
GroundPointingWrapper - Class in org.orekit.attitudes
This class leverages common parts for compensation modes around ground pointing attitudes.
GroundPointingWrapper(GroundPointing) - Constructor for class org.orekit.attitudes.GroundPointingWrapper
Creates a new instance.
GroundVelocityDirection - Class in org.orekit.attitudes.directions
Ground velocity direction.
GroundVelocityDirection(BodyShape, IDirection) - Constructor for class org.orekit.attitudes.directions.GroundVelocityDirection
Constructor
GRS80_EARTH_ANGULAR_VELOCITY - Static variable in interface org.orekit.utils.Constants
Earth angular velocity from GRS80 model: 7.292115e-5 rad/s.
GRS80_EARTH_C20 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized second zonal coefficient from GRS80 model: -1.08263e-3.
GRS80_EARTH_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.Constants
Earth equatorial radius from GRS80 model: 6378137.0 m.
GRS80_EARTH_FLATTENING - Static variable in interface org.orekit.utils.Constants
Earth flattening from GRS80 model: 1.0 / 298.257222101.
GRS80_EARTH_MU - Static variable in interface org.orekit.utils.Constants
Earth gravitational constant from GRS80 model: 3.986005e14 m3/s2.
gtd7(Input, Flags, Output) - Method in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
gtd7 : Neutral Atmosphere Empirical Model from the surface to lower exosphere.
gtd7d(Input, Flags, Output) - Method in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
gtd7d.
This subroutine provides Effective Total Mass Density for output d[5] which includes contributions from "anomalous oxygen" which can affect satellite drag above 500 km.
GTest - Class in org.apache.commons.math3.stat.inference
Implements G Test statistics.
GTest() - Constructor for class org.apache.commons.math3.stat.inference.GTest
 
gTest(double[], long[]) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.stat.inference.TestUtils
 
gTest(double[], long[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
gTestDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.stat.inference.GTest
Performs a G-Test (Log-Likelihood Ratio Test) comparing two binned data sets.
gTestDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
gTestDataSetsComparison(long[], long[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
gTestIntrinsic(double[], long[]) - Method in class org.apache.commons.math3.stat.inference.GTest
Returns the intrinsic (Hardy-Weinberg proportions) p-Value, as described in p64-69 of McDonald, J.H.
gTestIntrinsic(double[], long[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
GTODProvider - Class in org.orekit.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 org.orekit.frames.transformations.GTODProvider
Simple constructor.
guess() - Method in class org.apache.commons.math3.fitting.GaussianFitter.ParameterGuesser
Gets an estimation of the parameters.
guess() - Method in class org.apache.commons.math3.fitting.HarmonicFitter.ParameterGuesser
Gets an estimation of the parameters.
guess() - Method in class org.apache.commons.math3.optimization.fitting.GaussianFitter.ParameterGuesser
Deprecated. Gets an estimation of the parameters.
guess() - Method in class org.apache.commons.math3.optimization.fitting.HarmonicFitter.ParameterGuesser
Deprecated. Gets an estimation of the parameters.
guessParametersErrors() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. as of version 3.1, AbstractLeastSquaresOptimizer.computeSigma(double[],double) should be used instead. It should be emphasized that guessParametersErrors and computeSigma are not strictly equivalent.
GuidanceProfile - Class in fr.cnes.sirius.patrius.guidance
Represents a guidance profile
GuidanceProfile(AbsoluteDateInterval) - Constructor for class fr.cnes.sirius.patrius.guidance.GuidanceProfile
Constructor
GuidanceProfileBuilder - Class in fr.cnes.sirius.patrius.guidance
 
GZIP_FILE_PATTERN - Static variable in interface org.orekit.data.DataProvider
Pattern for name of gzip files.

H

h - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
current time step
H00 - Static variable in class org.orekit.time.TimeComponents
Constant for commonly used hour 00:00:00.
H0MinusNProvider - Class in org.orekit.frames.transformations
"H0 - n" reference frame.
H0MinusNProvider(AbsoluteDate, double) - Constructor for class org.orekit.frames.transformations.H0MinusNProvider
Simple constructor.
H12 - Static variable in class org.orekit.time.TimeComponents
Constant for commonly used hour 12:00:00.
HALF_PI - Static variable in class org.apache.commons.math3.util.MathUtils
π/2.
handleStep(StepInterpolator, boolean) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiEphemerisModeHandler
Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
Handle the last accepted step
handleStep(Map<String, SpacecraftState>, boolean) - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiOrekitFixedStepHandler
Handle the current step.
handleStep(MultiOrekitStepInterpolator, boolean) - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiOrekitStepHandler
Handle the current step.
handleStep(MultiOrekitStepInterpolator, boolean) - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiOrekitStepNormalizer
Handle the last accepted step.
handleStep(OrekitStepInterpolator, boolean) - Method in class fr.cnes.sirius.patrius.stela.propagation.ForcesStepHandler
 
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Handle the last accepted step.
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math3.ode.sampling.DummyStepHandler
Handle the last accepted step.
handleStep(double, double[], double[], boolean) - Method in interface org.apache.commons.math3.ode.sampling.FixedStepHandler
Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in interface org.apache.commons.math3.ode.sampling.StepHandler
Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math3.ode.sampling.StepNormalizer
Handle the last accepted step
handleStep(OrekitStepInterpolator, boolean) - Method in class org.orekit.propagation.analytical.AnalyticalEphemerisModeHandler
Handle the current step.
handleStep(StepInterpolator, boolean) - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Handle the last accepted step
handleStep(SpacecraftState, boolean) - Method in interface org.orekit.propagation.sampling.OrekitFixedStepHandler
Handle the current step.
handleStep(OrekitStepInterpolator, boolean) - Method in interface org.orekit.propagation.sampling.OrekitStepHandler
Handle the current step.
handleStep(OrekitStepInterpolator, boolean) - Method in class org.orekit.propagation.sampling.OrekitStepHandlerMultiplexer
Handle the current step.
handleStep(OrekitStepInterpolator, boolean) - Method in class org.orekit.propagation.sampling.OrekitStepNormalizer
Handle the last accepted step.
HarmonicFitter - Class in org.apache.commons.math3.fitting
Class that implements a curve fitting specialized for sinusoids.
HarmonicFitter(MultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.fitting.HarmonicFitter
Simple constructor.
HarmonicFitter - Class in org.apache.commons.math3.optimization.fitting
Deprecated. As of 3.1 (to be removed in 4.0).
HarmonicFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.HarmonicFitter
Deprecated. Simple constructor.
HarmonicFitter.ParameterGuesser - Class in org.apache.commons.math3.fitting
This class guesses harmonic coefficients from a sample.
HarmonicFitter.ParameterGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math3.fitting.HarmonicFitter.ParameterGuesser
Simple constructor.
HarmonicFitter.ParameterGuesser - Class in org.apache.commons.math3.optimization.fitting
Deprecated. This class guesses harmonic coefficients from a sample.
HarmonicFitter.ParameterGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math3.optimization.fitting.HarmonicFitter.ParameterGuesser
Deprecated. Simple constructor.
HarmonicOscillator - Class in org.apache.commons.math3.analysis.function
simple harmonic oscillator function.
HarmonicOscillator(double, double, double) - Constructor for class org.apache.commons.math3.analysis.function.HarmonicOscillator
Harmonic oscillator function.
HarmonicOscillator.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the harmonic oscillator function, ordered as follows: Amplitude Angular frequency Phase
HarmonicOscillator.Parametric() - Constructor for class org.apache.commons.math3.analysis.function.HarmonicOscillator.Parametric
 
HarrisPriester - Class in org.orekit.forces.atmospheres
This atmosphere model is the realization of the Modified Harris-Priester model.
HarrisPriester(PVCoordinatesProvider, BodyShape) - Constructor for class org.orekit.forces.atmospheres.HarrisPriester
Simple constructor for Modified Harris-Priester atmosphere model.
HarrisPriester(PVCoordinatesProvider, BodyShape, double) - Constructor for class org.orekit.forces.atmospheres.HarrisPriester
Constructor for Modified Harris-Priester atmosphere model.
HarrisPriester(PVCoordinatesProvider, BodyShape, double[][]) - Constructor for class org.orekit.forces.atmospheres.HarrisPriester
Constructor for Modified Harris-Priester atmosphere model.
HarrisPriester(PVCoordinatesProvider, BodyShape, double[][], double) - Constructor for class org.orekit.forces.atmospheres.HarrisPriester
Constructor for Modified Harris-Priester atmosphere model.
hasComplexEigenvalues() - Method in class org.apache.commons.math3.linear.EigenDecomposition
Returns whether the calculated eigen values are complex or real.
hash(double) - Static method in class org.apache.commons.math3.util.MathUtils
Returns an integer hash code representing the given double value.
hash(double[]) - Static method in class org.apache.commons.math3.util.MathUtils
Returns an integer hash code representing the given double array.
hashCode() - Method in class fr.cnes.sirius.patrius.events.CodedEvent
 
hashCode() - Method in class fr.cnes.sirius.patrius.events.Phenomenon
 
hashCode() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get a hashCode for the derivative structure.
hashCode() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
hashCode() - Method in class org.apache.commons.math3.complex.Complex
Get a hashCode for the complex number.
hashCode() - Method in class org.apache.commons.math3.complex.Quaternion
hashCode() - Method in class org.apache.commons.math3.dfp.Dfp
Gets a hashCode for the instance.
hashCode() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets a hashCode for the fraction.
hashCode() - Method in class org.apache.commons.math3.fraction.Fraction
Gets a hashCode for the fraction.
hashCode() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get a hashCode for the 1D vector.
hashCode() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a hashCode for the 3D vector.
hashCode() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Get a hashCode for the 3D matrix.
hashCode() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a hashCode for the 3D vector.
hashCode() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get a hashCode for the 2D vector.
hashCode() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
hashCode() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Computes a hashcode for the matrix.
hashCode() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Computes a hashcode for the matrix.
hashCode() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Get a hashCode for the real vector.
hashCode() - Method in class org.apache.commons.math3.linear.ArrayRealVector
.
hashCode() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. .
hashCode() - Method in class org.apache.commons.math3.linear.RealVector
.
hashCode() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. 
hashCode() - Method in class org.apache.commons.math3.optim.linear.LinearConstraint
 
hashCode() - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
 
hashCode() - Method in class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated.  
hashCode() - Method in class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.  
hashCode() - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
hashCode() - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns hash code based on getResult() and getN()
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math3.stat.Frequency
hashCode() - Method in class org.apache.commons.math3.util.BigReal
hashCode() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation returns the same value as new Double(this.doubleValue()).hashCode()
hashCode() - Method in class org.apache.commons.math3.util.DefaultTransformer
hashCode() - Method in class org.apache.commons.math3.util.Pair
Compute a hash code.
hashCode() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Returns a hash code consistent with equals.
hashCode() - Method in class org.apache.commons.math3.util.TransformerMap
hashCode() - Method in class org.orekit.time.AbsoluteDate
Get a hashcode for this date.
hashCode() - Method in class org.orekit.time.DateComponents
hashCode() - Method in class org.orekit.time.DateTimeComponents
hashCode() - Method in class org.orekit.time.TimeComponents
hashCode() - Method in class org.orekit.utils.ComparableInterval
 
hasIntercept() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
A getter method which determines whether a constant is included.
hasIntercept() - Method in class org.apache.commons.math3.stat.regression.RegressionResults
Returns true if the regression model has been computed including an intercept.
hasIntercept() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns true if the model includes an intercept term.
hasIntercept() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Returns true if a constant has been included false otherwise.
hasNext() - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapSparseIterator
Deprecated. 
hasNext() - Method in class org.apache.commons.math3.linear.RealVector.SparseEntryIterator
Deprecated. 
hasNext() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
hasNext() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
Check if there is a next element in the map.
hasNext() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
Check if there is a next element in the map.
hasProperty(PropertyType) - Method in interface fr.cnes.sirius.patrius.assembly.IPart
Checks if a property of the given type exists in this part.
hasProperty(PropertyType) - Method in class fr.cnes.sirius.patrius.assembly.MainPart
 
hasProperty(PropertyType) - Method in class fr.cnes.sirius.patrius.assembly.Part
 
HELIUM - Static variable in class org.orekit.forces.atmospheres.DTM2000
Identifier for helium.
HelmertTransformation - Class in org.orekit.frames.transformations
Transformation class for geodetic systems.
HelmertTransformation(AbsoluteDate, double, double, double, double, double, double, double, double, double, double, double, double) - Constructor for class org.orekit.frames.transformations.HelmertTransformation
Build a transform from its primitive operations.
HelmertTransformationFactory - Class in org.orekit.frames.transformations
Some Helmert transformations.
HelmholtzPolynomial - Class in org.apache.commons.math3.analysis.polynomials
This class represents Helmholtz polynomial.
HelmholtzPolynomial(int, int) - Constructor for class org.apache.commons.math3.analysis.polynomials.HelmholtzPolynomial
Create a Helmholtz polynomial with given degree and order
HermiteEphemeris - Class in org.orekit.propagation.precomputed
Deprecated. 
HermiteEphemeris(PVCoordinatesProvider, AttitudeProvider, AttitudeProvider, double, AbsoluteDateInterval, Frame, double) - Constructor for class org.orekit.propagation.precomputed.HermiteEphemeris
Deprecated. Constructor n°1 using a PV coordinates provider and an AttitudeProvider to build the interpolation points.
HermiteEphemeris(SpacecraftState[], Vector3D[]) - Constructor for class org.orekit.propagation.precomputed.HermiteEphemeris
Deprecated. Constructor of class HermiteEphemeris, where a search index algorithm is passed on the constructor.
HermiteEphemeris(SpacecraftState[]) - Constructor for class org.orekit.propagation.precomputed.HermiteEphemeris
Deprecated. Constructor of class HermiteEphemeris, used by other constructors of this class.
HermiteEphemeris(SpacecraftState[], ISearchIndex) - Constructor for class org.orekit.propagation.precomputed.HermiteEphemeris
Deprecated. Constructor of class HermiteEphemeris, where a search index algorithm is passed on the constructor.
HermiteEphemeris(SpacecraftState[], Vector3D[], ISearchIndex) - Constructor for class org.orekit.propagation.precomputed.HermiteEphemeris
Deprecated. Constructor of class HermiteEphemeris, where a search index algorithm is passed on the constructor.
HermiteInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Polynomial interpolator using both sample values and sample derivatives.
HermiteInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Create an empty interpolator.
HermiteInterpolator - Class in org.orekit.utils
Polynomial interpolator using both sample values and sample derivatives.
HermiteInterpolator() - Constructor for class org.orekit.utils.HermiteInterpolator
Create an empty interpolator.
HighamHall54Integrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 5(4) Higham and Hall integrator for Ordinary Differential Equations.
HighamHall54Integrator(double, double, double, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.HighamHall54Integrator
Simple constructor.
HighamHall54Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.nonstiff.HighamHall54Integrator
Simple constructor.
homoscedasticT(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticT(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticT(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a 2-sample t statistic, under the hypothesis of equal subpopulation variances.
homoscedasticT(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a 2-sample t statistic, comparing the means of the datasets described by two StatisticalSummary instances, under the assumption of equal subpopulation variances.
homoscedasticT(double, double, double, double, double, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes t test statistic for 2-sample t-test under the hypothesis of equal subpopulation variances.
homoscedasticTTest(double[], double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticTTest(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
homoscedasticTTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays, under the assumption that the two samples are drawn from subpopulations with equal variances.
homoscedasticTTest(double[], double[], double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha, assuming that the subpopulation variances are equal.
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances, under the hypothesis of equal subpopulation variances.
homoscedasticTTest(double, double, double, double, double, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes p-value for 2-sided, 2-sample t-test, under the assumption of equal subpopulation variances.
HOUR - Static variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Seconds in an hour
HYDROGEN - Static variable in class org.orekit.forces.atmospheres.DTM2000
Identifier for hydrogen.
HypergeometricDistribution - Class in org.apache.commons.math3.distribution
Implementation of the hypergeometric distribution.
HypergeometricDistribution(int, int, int) - Constructor for class org.apache.commons.math3.distribution.HypergeometricDistribution
Construct a new hypergeometric distribution with the specified population size, number of successes in the population, and sample size.
HypergeometricDistribution(RandomGenerator, int, int, int) - Constructor for class org.apache.commons.math3.distribution.HypergeometricDistribution
Creates a new hypergeometric distribution.
Hyperplane<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface represents an hyperplane of a space.
hypot(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the hypotenuse of a triangle with sides this and y - sqrt(this2 +y2)
avoiding intermediate overflow or underflow.
hypot(DerivativeStructure, DerivativeStructure) - Static method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the hypotenuse of a triangle with sides x and y - sqrt(x2 +y2)
avoiding intermediate overflow or underflow.
hypot(T) - Method in interface org.apache.commons.math3.RealFieldElement
Returns the hypotenuse of a triangle with sides this and y - sqrt(this2 +y2)
avoiding intermediate overflow or underflow.
hypot(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Returns the hypotenuse of a triangle with sides x and y - sqrt(x2 +y2)
avoiding intermediate overflow or underflow.

I

I - Static variable in class org.apache.commons.math3.complex.Complex
The square root of -1.
I - Static variable in class org.apache.commons.math3.complex.Quaternion
i
i - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
final inclination.
i1 - Variable in class org.apache.commons.math3.random.AbstractWell
Index indirection table giving for each index the value index + m1 taking table size into account.
i2 - Variable in class org.apache.commons.math3.random.AbstractWell
Index indirection table giving for each index the value index + m2 taking table size into account.
i3 - Variable in class org.apache.commons.math3.random.AbstractWell
Index indirection table giving for each index the value index + m3 taking table size into account.
I_LIM - Static variable in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Inclination upper limit.
IAUPole - Interface in org.orekit.bodies
Interface for IAU pole and primer meridian orientations.
IAUPoleFactory - Class in org.orekit.bodies
Factory class for IAU poles.
ICGEM_FILENAME - Static variable in class org.orekit.forces.gravity.potential.GravityFieldFactory
Default regular expression for ICGEM files.
ICGEMFormatReader - Class in org.orekit.forces.gravity.potential
Reader for the ICGEM gravity field format.
ICGEMFormatReader(String, boolean) - Constructor for class org.orekit.forces.gravity.potential.ICGEMFormatReader
Simple constructor.
Identity - Class in org.apache.commons.math3.analysis.function
Identity function.
Identity() - Constructor for class org.apache.commons.math3.analysis.function.Identity
 
IDENTITY - Static variable in class org.apache.commons.math3.complex.Quaternion
Identity quaternion.
IDENTITY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Identity rotation.
IDENTITY - Static variable in class org.orekit.frames.transformations.Transform
Identity transform.
IDENTITY - Static variable in class org.orekit.utils.AngularCoordinates
Fixed orientation parallel with reference frame (identity rotation, zero rotation rate, zero rotation acceleration).
identityPermutation(int) - Static method in class org.apache.commons.math3.genetics.RandomKey
Generates a representation corresponding to an identity permutation of length l which can be passed to the RandomKey constructor.
IdentityProjection - Class in fr.cnes.sirius.patrius.projections
This is the identity projection defined by
X = Lon
Y = Lat

IdentityProjection(ProjectionEllipsoid) - Constructor for class fr.cnes.sirius.patrius.projections.IdentityProjection
Constructor with ProjectionEllipsoid object.
IDependentVariable<T> - Interface in org.apache.commons.math3.analysis
Generic interface to describe a T-dependent variable.
IDependentVectorVariable<T> - Interface in org.apache.commons.math3.analysis
Generic interface to describe a T-dependent 3D vector.
IDirection - Interface in org.orekit.attitudes.directions
This is the main interface for directions.
IEEEremainder(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Computes the remainder as prescribed by the IEEE 754 standard.
IEllipsoid - Interface in org.apache.commons.math3.geometry.euclidean.threed
Interface for Ellipsoid objects.
IEmissivityModel - Interface in org.orekit.forces.radiation
This is the interface for all emissivity models (albedo and infrared).
IEphemerisBody - Interface in fr.cnes.sirius.validate.mocks.ephemeris
Interface representing a celestial body, with a name, an attraction coefficient and a definition for the IAU pole.
IERS20032010PrecessionNutation - Class in org.orekit.frames.configuration.precessionnutation
This class implement the IERS 2003 and 2010 Precession Nutation models.
IERS20032010PrecessionNutation(PrecessionNutationConvention, boolean) - Constructor for class org.orekit.frames.configuration.precessionnutation.IERS20032010PrecessionNutation
Constructor.
IERS2003TidalCorrection - Class in org.orekit.frames.configuration.tides
Compute tidal correction to the pole motion.
IERS2003TidalCorrection() - Constructor for class org.orekit.frames.configuration.tides.IERS2003TidalCorrection
Simple constructor.
IERS2010LibrationCorrection - Class in org.orekit.frames.configuration.libration
This class computes the diurnal lunisolar effect.
IERS2010LibrationCorrection() - Constructor for class org.orekit.frames.configuration.libration.IERS2010LibrationCorrection
Simple constructor.
IERS2010SPCorrection - Class in org.orekit.frames.configuration.sp
Compute s' correction.
IERS2010SPCorrection() - Constructor for class org.orekit.frames.configuration.sp.IERS2010SPCorrection
Simple constructor.
IERS2010TidalCorrection - Class in org.orekit.frames.configuration.tides
This class applies the integral Ray model (71 tidal waves) and Brzezinski-Mathews-Bretagnon-Capitaine-Bizouard model (10 lunisolar waves) of the semidiurnal/diurnal variations in the Earth's orientation as recommended in the IERS 2003 Conventions (McCarthy, 2002).
IERS2010TidalCorrection() - Constructor for class org.orekit.frames.configuration.tides.IERS2010TidalCorrection
Constructor.
IERS92_EARTH_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Earth standard gravitational parameter (m) from CNES COMPAS_Base data set.
IERS92_EARTH_FLATTENING - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Earth flattening from CNES COMPAS_Base data set.
IERS92_EARTH_GRAVITATIONAL_PARAMETER - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Earth standard gravitational parameter (m3s2) from CNES COMPAS_Base data set.
IERS92_EARTH_J2 - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Earth J2 parameter from CNES COMPAS_Base data set.
IERS92_EARTH_ROTATION_RATE - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Earth rotation rate (rad/s) from CNES COMPAS_Base data set.
IERS92_LIGHT_VELOCITY - Static variable in interface org.orekit.utils.CnesConstants
IERS92 light velocity in vacuum (meters per second) from CNES COMPAS_Base data set.
IERS92_MOON_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Moon equatorial radius from CNES COMPAS_Base data set.
IERS92_MOON_FLATTENING - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Moon flattening from CNES COMPAS_Base data set.
IERS92_MOON_GRAVITATIONAL_PARAMETER - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Moon standard gravitational parameter from CNES COMPAS_Base data set.
IERS92_MOON_ROTATION_RATE - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Moon rotation rate from CNES COMPAS_Base data set.
IERS92_SUN_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Sun equatorial radius from CNES COMPAS_Base data set.
IERS92_SUN_FLATTENING - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Sun flattening from CNES COMPAS_Base data set.
IERS92_SUN_GRAVITATIONAL_PARAMETER - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Sun standard gravitational parameter from CNES COMPAS_Base data set.
IERS92_SUN_ROTATION_RATE - Static variable in interface org.orekit.utils.CnesConstants
IERS92 Sun rotation rate from CNES COMPAS_Base data set.
IERS92_UA - Static variable in interface org.orekit.utils.CnesConstants
IERS92 UA (m) from CNES COMPAS_Base data set.
IFastFourierTransformer - Interface in org.apache.commons.math3.transform
This interface gathers all the FFT algorithms of this library.
IFieldOfView - Interface in fr.cnes.sirius.patrius.fieldsofview
This is the interface for all the field of view (circular, elliptic...).
IInertiaModel - Interface in fr.cnes.sirius.patrius.assembly.models
 
IInertiaProperty - Interface in fr.cnes.sirius.patrius.assembly.properties
This is the interface for all inertia properties : those properties can provide the inertia matrix, mass and mass center of the part, and the frame in which the vector and the matrix are expressed.
IJacobiansParameterizable - Interface in org.orekit.parameter
This class is used to define jacobian function parameters.
iLaw - Variable in class org.orekit.attitudes.AbstractSlew
The attitude law before the slew.
IllConditionedOperatorException - Exception in org.apache.commons.math3.linear
An exception to be thrown when the condition number of a RealLinearOperator is too high.
IllConditionedOperatorException(double) - Constructor for exception org.apache.commons.math3.linear.IllConditionedOperatorException
Creates a new instance of this class.
IllinoisSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Illinois method for root-finding (approximating a zero of a univariate real function).
IllinoisSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
Construct a solver with default accuracy (1e-6).
IllinoisSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
Construct a solver.
IllinoisSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
Construct a solver.
IllinoisSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.IllinoisSolver
Construct a solver.
iMax - Variable in class org.apache.commons.math3.utils.AbstractSearchIndex
The upper bound of tab to consider for the search index algorithm.
iMin - Variable in class org.apache.commons.math3.utils.AbstractSearchIndex
The lower bound of tab to consider for the search index algorithm.
ImpulseManeuver - Class in org.orekit.forces.maneuvers
Impulse maneuver model.
ImpulseManeuver(EventDetector, Vector3D, double, MassProvider, String) - Constructor for class org.orekit.forces.maneuvers.ImpulseManeuver
Build a new instance.
ImpulseManeuver(EventDetector, Vector3D, Frame, double, MassProvider, String) - Constructor for class org.orekit.forces.maneuvers.ImpulseManeuver
Build a new instance.
ImpulseManeuver(EventDetector, Vector3D, double, MassProvider, String, LOFType) - Constructor for class org.orekit.forces.maneuvers.ImpulseManeuver
Build a new instance with a LocalOrbitalFrame.
includes(ComparableInterval<T>) - Method in class org.orekit.utils.ComparableInterval
Returns true when this interval includes the other.
incMoment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Determines whether or not this statistic can be incremented or cleared.
incMoment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Mean
Determines whether or not this statistic can be incremented or cleared.
incMoment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Determines whether or not this statistic can be incremented or cleared.
incMoment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Variance
Whether or not Variance.increment(double) should increment the internal second moment.
INCREASING - Static variable in interface org.apache.commons.math3.ode.events.EventHandler
Increasing g-function related events parameter.
INCREASING - Static variable in interface org.orekit.propagation.events.EventDetector
Increasing g-function related events parameter.
INCREASING - Static variable in interface org.orekit.propagation.events.multi.MultiEventDetector
Increasing g-function related events parameter.
INCREASING_DECREASING - Static variable in interface org.apache.commons.math3.ode.events.EventHandler
Both increasing and decreasing g-function related events parameter.
INCREASING_DECREASING - Static variable in interface org.orekit.propagation.events.EventDetector
Both increasing and decreasing g-function related events parameter.
INCREASING_DECREASING - Static variable in interface org.orekit.propagation.events.multi.MultiEventDetector
Both increasing and decreasing g-function related events parameter.
increment(double[]) - Method in class org.apache.commons.math3.stat.correlation.StorelessCovariance
Increment the covariance matrix with one row of data.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Mean
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Add a new vector to the sample.
increment(double[]) - Method in class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
Add a new vector to the sample.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Max
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Min
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.Product
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.Sum
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Updates the internal state of the statistic to reflect the addition of the new value.
incrementAll(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation just calls AbstractStorelessUnivariateStatistic.increment(double) in a loop over the input array.
incrementAll(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation just calls AbstractStorelessUnivariateStatistic.increment(double) in a loop over the specified portion of the input array.
incrementAll(double[]) - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect addition of all values in the values array.
incrementAll(double[], int, int) - Method in interface org.apache.commons.math3.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect addition of the values in the designated portion of the values array.
incrementCount(int) - Method in class org.apache.commons.math3.util.Incrementor
Performs multiple increments.
incrementCount() - Method in class org.apache.commons.math3.util.Incrementor
Adds one to the current iteration count.
incrementEvaluationCount() - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Increment the evaluation count by one.
incrementEvaluationCount() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Increment the evaluation count.
incrementIterationCount() - Method in class org.apache.commons.math3.optim.BaseOptimizer
Increment the iteration count.
incrementIterationCount() - Method in class org.apache.commons.math3.util.IterationManager
Increments the iteration count by one, and throws an exception if the maximum number of iterations is reached.
incrementIterationsCounter() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated. Increment the iterations counter by 1.
Incrementor - Class in org.apache.commons.math3.util
Utility that increments a counter until a maximum is reached, at which point, the instance will by default throw a MaxCountExceededException.
Incrementor() - Constructor for class org.apache.commons.math3.util.Incrementor
Default constructor.
Incrementor(int) - Constructor for class org.apache.commons.math3.util.Incrementor
Defines a maximal count.
Incrementor(int, Incrementor.MaxCountExceededCallback) - Constructor for class org.apache.commons.math3.util.Incrementor
Defines a maximal count and a callback method to be triggered at counter exhaustion.
Incrementor.MaxCountExceededCallback - Interface in org.apache.commons.math3.util
Defines a method to be called at counter exhaustion.
incrementValue(Comparable<?>, long) - Method in class org.apache.commons.math3.stat.Frequency
Increments the frequency count for v.
index - Variable in class org.apache.commons.math3.random.AbstractWell
Current index in the bytes pool.
indexValidity(SpacecraftState[], int) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
Checks if interpolation is valid : meaning if 0<= index +1 -interpOrder/2 or index + interpOrder/2 <= maximalIndex
inducedPermutation(List<S>, List<S>) - Static method in class org.apache.commons.math3.genetics.RandomKey
Generates a representation of a permutation corresponding to a permutation which yields permutedData when applied to originalData.
InertiaComputedModel - Class in fr.cnes.sirius.patrius.assembly.models
This class is an inertia model computed from the inertia properties of each parts of an Assembly object.
InertiaComputedModel(Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
Constructor for the computed inertia model.
InertiaCylinderProperty - Class in fr.cnes.sirius.patrius.assembly.properties
Inertia property for a cylinder part.
InertiaCylinderProperty(double, double, MassProperty) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.InertiaCylinderProperty
Constructor for the cylinder inertia property.
InertialProvider - Class in org.orekit.attitudes
Deprecated. 
InertialProvider(Rotation) - Constructor for class org.orekit.attitudes.InertialProvider
Deprecated. Creates new instance.
InertiaParallelepipedProperty - Class in fr.cnes.sirius.patrius.assembly.properties
Inertia property for a parallelepipedic part.
InertiaParallelepipedProperty(double, double, double, MassProperty) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.InertiaParallelepipedProperty
Constructor for the parallelepiped inertia property.
InertiaSimpleModel - Class in fr.cnes.sirius.patrius.assembly.models
Simple inertia model : the mass, mass center and inertia matrix are directly given by the user.
InertiaSimpleModel(double, Vector3D, Matrix3D, Frame, String) - Constructor for class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
Constructor for a simple inertia model.
InertiaSimpleModel(double, Vector3D, Matrix3D, Vector3D, Frame, String) - Constructor for class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
Constructor for a simple inertia model; the inertia matrix is expressed with respect to a point that can be different from the mass center.
InertiaSimpleProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is a simple inertia property that can be added to a part.
InertiaSimpleProperty(Vector3D, Matrix3D, MassProperty) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.InertiaSimpleProperty
Constructor for the simple inertia property
InertiaSimpleProperty(Vector3D, Matrix3D, Vector3D, MassProperty) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.InertiaSimpleProperty
Constructor for the simple inertia property; the inertia matrix is expressed with respect to a point that can be different from the mass center.
InertiaSphereProperty - Class in fr.cnes.sirius.patrius.assembly.properties
Inertia property for a spherical part.
InertiaSphereProperty(double, MassProperty) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.InertiaSphereProperty
Constructor for the spherical inertia property.
INF - Static variable in class org.apache.commons.math3.complex.Complex
A complex number representing "+INF + INFi"
INFINITE - Static variable in class org.apache.commons.math3.dfp.Dfp
Indicator value for Infinity.
INFINITE_WINDOW - Static variable in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Represents an infinite window size.
InfiniteCone - Interface in org.apache.commons.math3.geometry.euclidean.threed
This interface extends the infinite shape for the particular cases of infinite cones.
InfiniteCylinder - Interface in org.apache.commons.math3.geometry.euclidean.threed
This interface extends the infinite shape for the particular cases of infinite cylinders.
InfiniteEllipticCone - Class in org.apache.commons.math3.geometry.euclidean.threed
This class is the Infinite Oblique Circular Cone class.
InfiniteEllipticCone(Vector3D, Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This is the constructor for the class InfiniteObliqueCircularCone.
InfiniteEllipticCylinder - Class in org.apache.commons.math3.geometry.euclidean.threed
This class is the Infinite Elliptic Cylinder class.
InfiniteEllipticCylinder(Vector3D, Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
This is the constructor for the class InfiniteEllipticCylinder.
InfiniteRectangleCone - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D infinite cone, with some algorithm to compute intersections and distances to some other objects.
InfiniteRectangleCone(Vector3D, Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
Build an infinite rectangle cone from the position of its origin, its axis, a vector defining the orientation of the rectangle and two angles
InfiniteRectangleCylinder - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D infinite rectangle cylinder, with some algorithm to compute intersections and distances to some other objects.
InfiniteRectangleCylinder(Line, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
Build an infinite rectangle cylinder from its dimensions, orientation and the origin and direction of its axis
InfiniteRectangleCylinder(Vector3D, Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
Build an infinite rectangle cylinder from its dimensions, orientation and the origin and direction of its axis
InfiniteRightCircularCone - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D infinite cone, with some algorithm to compute intersections and distances to some other objects.
InfiniteRightCircularCone(Vector3D, Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCone
Build an infinite elliptic cone from its angle, the position of its origin and its axis
InfiniteRightCircularCylinder - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D infinite right circular cylinder, with some algorithm to compute intersections and distances to some other objects.
InfiniteRightCircularCylinder(Line, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
Build an infinite right circular cylinder from its radius and its axis as a line
InfiniteRightCircularCylinder(Vector3D, Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
Build an infinite right circular cylinder from its radius and the origin and direction of its axis
InfiniteShape - Interface in org.apache.commons.math3.geometry.euclidean.threed
Interface for all infinite shapes.
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.CombinedPhenomenaDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.EarthZoneDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Initialize event handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
 
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.SensorInhibitionDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.StationToSatMutualVisibilityDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
Initialize event handler at the start of a propagation.
init(double, double[], double) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMonoEventDetector
 
init(double, double[], double) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMultiEventDetector
 
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
 
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.OneSatEventDetectorWrapper
 
init(double, double[], double) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiEphemerisModeHandler
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
Initialize step handler at the start of an ODE integration.
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiOrekitFixedStepHandler
Initialize step handler at the start of a propagation.
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiOrekitStepHandler
Initialize step handler at the start of a propagation.
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiOrekitStepNormalizer
Initialize step handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.ForcesStepHandler
 
init(double, double[], double) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in interface org.apache.commons.math3.ode.events.EventHandler
Initialize event handler at the start of an ODE integration.
init(double, double[], double) - Method in class org.apache.commons.math3.ode.sampling.DummyStepHandler
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in interface org.apache.commons.math3.ode.sampling.FixedStepHandler
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in interface org.apache.commons.math3.ode.sampling.StepHandler
Initialize step handler at the start of an ODE integration.
init(double, double[], double) - Method in class org.apache.commons.math3.ode.sampling.StepNormalizer
Initialize step handler at the start of an ODE integration.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Initialize event handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.analytical.AnalyticalEphemerisModeHandler
Initialize step handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.AbstractDetector
Initialize event handler at the start of a propagation.
init(double, double[], double) - Method in class org.orekit.propagation.events.AdaptedEventDetector
Initialize event handler at the start of an ODE integration.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.AnomalyDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.AOLDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.BetaAngleDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.DistanceDetector
 
init(SpacecraftState, AbsoluteDate) - Method in interface org.orekit.propagation.events.EventDetector
Initialize event handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.EventShifter
Initialize event handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.ExtremaDistanceDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.ExtremaElevationDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.ExtremaLatitudeDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.ExtremaLongitudeDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
 
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.LatitudeDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.LocalTimeDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.LongitudeDetector
 
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in interface org.orekit.propagation.events.multi.MultiEventDetector
Initialize event handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.NadirSolarIncidenceDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Initialize event handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.SolarTimeDetector
 
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
 
init(Map<String, SpacecraftState>, AbsoluteDate) - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
 
init(double, double[], double) - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Initialize step handler at the start of an ODE integration.
init(SpacecraftState, AbsoluteDate) - Method in interface org.orekit.propagation.sampling.OrekitFixedStepHandler
Initialize step handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in interface org.orekit.propagation.sampling.OrekitStepHandler
Initialize step handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.sampling.OrekitStepHandlerMultiplexer
Initialize step handler at the start of a propagation.
init(SpacecraftState, AbsoluteDate) - Method in class org.orekit.propagation.sampling.OrekitStepNormalizer
Initialize step handler at the start of a propagation.
initDerivatives() - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
 
initDerivatives() - Method in interface org.orekit.forces.radiation.RediffusedRadiationSensitive
derivatives initialisation
initDerivatives(double[], Orbit) - Method in interface org.orekit.propagation.numerical.TimeDerivativesEquations
Initialize all derivatives to zero.
InitialGuess - Class in org.apache.commons.math3.optim
Starting point (first guess) of the optimization procedure.
InitialGuess(double[]) - Constructor for class org.apache.commons.math3.optim.InitialGuess
 
InitialGuess - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
InitialGuess(double[]) - Constructor for class org.apache.commons.math3.optimization.InitialGuess
Deprecated.  
initializationPerformed(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
Invoked after completion of the initial phase of the iterative algorithm (prior to the main iteration loop).
initialize(OrbitType, PositionAngle, Map<String, AttitudeProvider>, Map<String, AttitudeProvider>, MultiStateVectorInfo, boolean, AbsoluteDate, Map<String, Frame>, Map<String, Double>) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiEphemerisModeHandler
Initialize the mode handler.
initialize(OrbitType, PositionAngle, Map<String, AttitudeProvider>, Map<String, AttitudeProvider>, MultiStateVectorInfo, boolean, AbsoluteDate, Map<String, Frame>, Map<String, Double>) - Method in interface fr.cnes.sirius.patrius.propagation.numerical.multi.MultiModeHandler
Initialize the mode handler.
initialize(OrbitType, PositionAngle, Map<String, AttitudeProvider>, Map<String, AttitudeProvider>, MultiStateVectorInfo, boolean, AbsoluteDate, Map<String, Frame>, Map<String, Double>) - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
Initialize the mode handler.
initialize(OrbitType, PositionAngle, AttitudeProvider, AttitudeProvider, Map<String, AdditionalStateInfo>, boolean, AbsoluteDate, Frame, double) - Method in interface org.orekit.propagation.numerical.ModeHandler
Initialize the mode handler.
initialize(OrbitType, PositionAngle, AttitudeProvider, AttitudeProvider, Map<String, AdditionalStateInfo>, boolean, AbsoluteDate, Frame, double) - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Initialize the mode handler.
initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Initialize the high order scaled derivatives at step start.
initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in interface org.apache.commons.math3.ode.MultistepIntegrator.NordsieckTransformer
Initialize the high order scaled derivatives at step start.
initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Initialize the high order scaled derivatives at step start.
initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Initialize the high order scaled derivatives at step start.
initializeStep(boolean, int, double[], double, double[], double[], double[], double[], double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Initialize the integration step.
initIntegration(double, double[], double) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Prepare the start of an integration.
initMainPartFrame(UpdatableFrame) - Method in class fr.cnes.sirius.patrius.assembly.Assembly
Initialize the main part's frame using a UpdatableFrame as an input argument.
initMainPartFrame(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.Assembly
Initialize the main part's frame using a SpacecraftState as an input argument.
initMainPartFrame(UpdatableFrame) - Method in class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
Sets up the frame of the main part.
initMainPartFrame(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
Sets up the main frame of the assembly from a "SpacecraftState" object.
initPVCoordinates() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
 
initPVCoordinates() - Method in class org.orekit.orbits.ApsisOrbit
Compute the position/velocity coordinates from the canonical parameters.
initPVCoordinates() - Method in class org.orekit.orbits.CartesianOrbit
Compute the position/velocity coordinates from the canonical parameters.
initPVCoordinates() - Method in class org.orekit.orbits.CircularOrbit
Compute the position/velocity coordinates from the canonical parameters.
initPVCoordinates() - Method in class org.orekit.orbits.EquatorialOrbit
Compute the position/velocity coordinates from the canonical parameters.
initPVCoordinates() - Method in class org.orekit.orbits.EquinoctialOrbit
Compute the position/velocity coordinates from the canonical parameters.
initPVCoordinates() - Method in class org.orekit.orbits.KeplerianOrbit
Compute the position/velocity coordinates from the canonical parameters.
initPVCoordinates() - Method in class org.orekit.orbits.Orbit
Compute the position/velocity coordinates from the canonical parameters.
initSetup(URI) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
create a Setup object to handle the setup information
Input - Class in org.orekit.forces.atmospheres.MSIS2000
Class Input NOTES ON INPUT VARIABLES: UT, Local Time, and Longitude are used independently in the model and are not of equal importance for every situation.
Input() - Constructor for class org.orekit.forces.atmospheres.MSIS2000.Input
Constructor
inRange(AbsoluteDate) - Method in class org.orekit.bodies.PosVelChebyshev
Check if a date is in validity range.
insert(T) - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Insert an element in the tree.
insertCut(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Insert a cut sub-hyperplane in a node.
insertEquationData(double[], double[]) - Method in class org.apache.commons.math3.ode.EquationsMapper
Insert equation data into a complete state or derivative array.
insertInTree(BSPTree<S>, boolean) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Insert the instance into another tree.
insideLeap(AbsoluteDate) - Method in class org.orekit.time.UTCScale
Check if date is within a leap second introduction.
IntegerDistribution - Interface in org.apache.commons.math3.distribution
Interface for distributions on the integers.
IntegrableUnivariateFunction - Interface in org.apache.commons.math3.analysis
Extension of UnivariateFunction representing an integrable univariate real function.
integral(double, double) - Method in class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
Returns the integral of the vector function in the given interval.
integral(double, double) - Method in class org.orekit.attitudes.kinematics.AbstractVector3DFunction
Returns the integral of the vector function in the given interval.
integral(double, double) - Method in interface org.orekit.attitudes.kinematics.Vector3DFunction
Returns the integral of the vector function in the given interval.
integrate(int, UnivariateFunction, double, double) - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Integrate the function in the given interval.
integrate(UnivariateFunction) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegrator
Returns an estimate of the integral of f(x) * w(x), where w is a weight function that depends on the actual flavor of the Gauss integration scheme.
integrate(int, UnivariateFunction, double, double) - Method in interface org.apache.commons.math3.analysis.integration.UnivariateIntegrator
Integrate the function in the given interval.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Integrate the differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Integrate a set of differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in interface org.apache.commons.math3.ode.FirstOrderIntegrator
Integrate the differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsBashforthIntegrator
Integrate a set of differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Integrate a set of differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsMoultonIntegrator
Integrate a set of differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Integrate a set of differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Integrate a set of differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Integrate a set of differential equations up to the given time.
integrate(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.RungeKuttaIntegrator
Integrate a set of differential equations up to the given time.
integrate(SecondOrderDifferentialEquations, double, double[], double[], double, double[], double[]) - Method in interface org.apache.commons.math3.ode.SecondOrderIntegrator
Integrate the differential equations up to the given time
integrate(KinematicsToolkit.IntegrationType, Rotation, AbsoluteDate, AbsoluteDate, Vector3DFunction, double) - Static method in class org.orekit.attitudes.kinematics.KinematicsToolkit
Integrate a spin function.
IntegratedEphemeris - Class in org.orekit.propagation.precomputed
This class stores sequentially generated orbital parameters for later retrieval.
IntegratedEphemeris(List<AbsoluteDate>, List<AbsoluteDate>, List<AbsoluteDate>, OrbitType, PositionAngle, AttitudeProvider, AttitudeProvider, Map<String, AdditionalStateInfo>, List<ContinuousOutputModel>, Frame, double) - Constructor for class org.orekit.propagation.precomputed.IntegratedEphemeris
Creates a new instance of IntegratedEphemeris.
integrator - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Integrator for the orbital extrapolation process.
interp1D(double, double, double, double, double) - Method in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Interpolates in 1D.
interp2D(double, double, double, double, double, double, double, double, double, double) - Method in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Interpolates in 2D by 2-successives 1D interpolation.
interpolate(AbsoluteDate, Collection<Orbit>) - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Get an interpolated instance.
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math3.analysis.interpolation.BiLinearIntervalsInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[], double[][]) - Method in interface org.apache.commons.math3.analysis.interpolation.BivariateGridInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.DividedDifferenceInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LinearInterpolator
Computes a linear interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Compute an interpolating function by performing a loess fit on the data at the original abscissae and then building a cubic spline with a SplineInterpolator on the resulting fit.
interpolate(double[][], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Computes an interpolating function for the data set.
interpolate(double[][], double[]) - Method in interface org.apache.commons.math3.analysis.interpolation.MultivariateInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.NevilleInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.SplineInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[], double[], double[][][]) - Method in class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[], double[], double[][][]) - Method in class org.apache.commons.math3.analysis.interpolation.TriLinearIntervalsInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[], double[], double[][][]) - Method in interface org.apache.commons.math3.analysis.interpolation.TrivariateGridInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.UniLinearIntervalsInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in interface org.apache.commons.math3.analysis.interpolation.UnivariateInterpolator
Compute an interpolating function for the dataset.
interpolate(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
Compute an interpolating function for the dataset.
interpolate(AbsoluteDate, Collection<Attitude>) - Method in class org.orekit.attitudes.Attitude
Get an interpolated instance.
interpolate(AbsoluteDate, Collection<Attitude>, boolean) - Method in class org.orekit.attitudes.Attitude
Interpolates attitude.
interpolate(Rotation, Rotation, double) - Method in interface org.orekit.attitudes.kinematics.RotationInterpolator
Deprecated. Interpolates a rotation between two given ones.
interpolate(Rotation, Rotation, double) - Method in class org.orekit.attitudes.kinematics.SlerpInterpolator
Deprecated. Interpolates a rotation between two given ones.
interpolate(AbsoluteDate, Collection<Transform>) - Method in class org.orekit.frames.transformations.Transform
Get an interpolated instance.
interpolate(AbsoluteDate, Collection<Transform>, boolean) - Method in class org.orekit.frames.transformations.Transform
Get an interpolated instance.
interpolate(AbsoluteDate, boolean, boolean, Collection<Transform>) - Static method in class org.orekit.frames.transformations.Transform
Interpolate a transform from a sample set of existing transforms.
interpolate(AbsoluteDate, boolean, boolean, Collection<Transform>, boolean) - Static method in class org.orekit.frames.transformations.Transform
Interpolate a transform from a sample set of existing transforms.
interpolate(AbsoluteDate, Collection<Orbit>) - Method in class org.orekit.orbits.ApsisOrbit
Get an interpolated instance.
interpolate(AbsoluteDate, Collection<Orbit>) - Method in class org.orekit.orbits.CartesianOrbit
Get an interpolated instance.
interpolate(AbsoluteDate, Collection<Orbit>) - Method in class org.orekit.orbits.CircularOrbit
Get an interpolated instance.
interpolate(AbsoluteDate, Collection<Orbit>) - Method in class org.orekit.orbits.EquatorialOrbit
Get an interpolated instance.
interpolate(AbsoluteDate, Collection<Orbit>) - Method in class org.orekit.orbits.EquinoctialOrbit
Get an interpolated instance.
interpolate(AbsoluteDate, Collection<Orbit>) - Method in class org.orekit.orbits.KeplerianOrbit
Get an interpolated instance.
interpolate(AbsoluteDate) - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
Computes the interpolation of a covariance matrix based on its two surrounding covariance matrices which define the interpolation interval allowed.
interpolate(AbsoluteDate, Collection<SpacecraftState>) - Method in class org.orekit.propagation.SpacecraftState
Get an interpolated instance.
interpolate(AbsoluteDate, Collection<T>) - Method in interface org.orekit.time.TimeInterpolable
Get an interpolated instance.
interpolate(AbsoluteDate, boolean, Collection<Pair<AbsoluteDate, AngularCoordinates>>) - Static method in class org.orekit.utils.AngularCoordinates
Deprecated. since 3.1 replaced with TimeStampedAngularCoordinates.interpolate(AbsoluteDate, AngularDerivativesFilter, Collection)
interpolate(AbsoluteDate, boolean, Collection<Pair<AbsoluteDate, AngularCoordinates>>, boolean) - Static method in class org.orekit.utils.AngularCoordinates
Deprecated. since 3.1 replaced with TimeStampedAngularCoordinates.interpolate(AbsoluteDate, AngularDerivativesFilter, Collection, boolean)
interpolate(AbsoluteDate, boolean, Collection<Pair<AbsoluteDate, PVCoordinates>>) - Static method in class org.orekit.utils.PVCoordinates
Deprecated. since 3.1 replaced with TimeStampedPVCoordinates.interpolate(AbsoluteDate, CartesianDerivativesFilter, Collection)
interpolate(AbsoluteDate, AngularDerivativesFilter, Collection<TimeStampedAngularCoordinates>) - Static method in class org.orekit.utils.TimeStampedAngularCoordinates
Interpolate angular coordinates.
interpolate(AbsoluteDate, AngularDerivativesFilter, Collection<TimeStampedAngularCoordinates>, boolean) - Static method in class org.orekit.utils.TimeStampedAngularCoordinates
Interpolate angular coordinates.
interpolate(AbsoluteDate, CartesianDerivativesFilter, Collection<TimeStampedPVCoordinates>) - Static method in class org.orekit.utils.TimeStampedPVCoordinates
Interpolate position-velocity.
interpolateArray(AbsoluteDate) - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
Computes the interpolation of a covariance matrix based on its two surrounding covariance matrices which define the interpolation interval allowed.
interpolatedDerivatives - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
interpolated derivatives
interpolatedPrimaryDerivatives - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
interpolated primary derivatives
interpolatedPrimaryState - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
interpolated primary state
interpolatedSecondaryDerivatives - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
interpolated secondary derivatives
interpolatedSecondaryState - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
interpolated secondary state
interpolatedState - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
interpolated state
interpolatedTime - Variable in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
interpolated time
InterpolatingTransformProvider - Class in org.orekit.frames.transformations
Transform provider using thread-safe interpolation on transforms sample.
InterpolatingTransformProvider(TransformProvider, boolean, boolean, AbsoluteDate, AbsoluteDate, int, double, int, double, double) - Constructor for class org.orekit.frames.transformations.InterpolatingTransformProvider
Simple constructor.
InterpolatingTransformProvider(TransformProvider, boolean, boolean, AbsoluteDate, AbsoluteDate, int, double, int, double, double, boolean) - Constructor for class org.orekit.frames.transformations.InterpolatingTransformProvider
Simple constructor.
interpolationInterval - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
Ephemeris interval of validity.
InterpolationTableLoader - Class in org.orekit.utils
Used to read an interpolation table from a data file.
InterpolationTableLoader() - Constructor for class org.orekit.utils.InterpolationTableLoader
 
interpOrder - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
Interpolation order.
intersection(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get the intersection point of the instance and another line.
intersection(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the intersection of a line with the instance.
intersection(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build the line shared by the instance and another plane.
intersection(Plane, Plane, Plane) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Get the intersection point of three planes.
intersection(SubLine, boolean) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Get the intersection of the instance and another sub-line.
intersection(Line) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Get the intersection point of the instance and another line.
intersection(SubLine, boolean) - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Get the intersection of the instance and another sub-line.
intersection(SubHyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Get the parts of a sub-hyperplane that are contained in the region.
intersection(SubHyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Get the parts of a sub-hyperplane that are contained in the region.
intersection(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Compute the intersection of two regions.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.AbstractEllipse
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
This method returns true if the line intersects the ellipsoid
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
This method returns true if the user specified line intersects the cone.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
This method returns true if the user specified line intersects the cylinder.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCone
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
Tests the intersection with a line.
intersects(Line) - Method in interface org.apache.commons.math3.geometry.euclidean.threed.Shape
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Tests the intersection with a line.
intersects(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCap
Returns true when the line intersects the spherical cap.
Interval - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents a 1D interval.
Interval(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Interval
Simple constructor.
IntervalEndpointType - Enum in org.orekit.utils
- Describes the type of an interval endpoint : OPENED or CLOSED.
intervalOfValidity - Variable in class org.orekit.attitudes.AbstractSlew
Interval of validity of the maneuver (with closed endpoints).
IntervalsSet - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents a 1D region: a set of intervals.
IntervalsSet() - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an intervals set representing the whole real line.
IntervalsSet(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an intervals set corresponding to a single interval.
IntervalsSet(BSPTree<Euclidean1D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an intervals set from an inside/outside BSP tree.
IntervalsSet(Collection<SubHyperplane<Euclidean1D>>) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.IntervalsSet
Build an intervals set from a Boundary REPresentation (B-rep).
intervalValidity(SpacecraftState[]) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
Corrects the min and max dates with the constraint of the number of interpolations points required.
intValue() - Method in class org.apache.commons.math3.dfp.Dfp
Convert this to an integer.
intValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as an int.
intValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction as an int.
intValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a int.
InvalidRepresentationException - Exception in org.apache.commons.math3.genetics
Exception indicating that the representation of a chromosome is not valid.
InvalidRepresentationException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.genetics.InvalidRepresentationException
Construct an InvalidRepresentationException with a specialized message.
Inverse - Class in org.apache.commons.math3.analysis.function
Inverse function.
Inverse() - Constructor for class org.apache.commons.math3.analysis.function.Inverse
 
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.TriangularDistribution
 
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Computes the quantile function of this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Computes the quantile function of this distribution.
InvertField - Class in fr.cnes.sirius.patrius.fieldsofview
This field of view contains an existing field and inverts it.
InvertField(String, IFieldOfView) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.InvertField
Constructor of the invert field of a given one.
invGamma1pm1(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the value of 1 / Γ(1 + x) - 1 for -0.5 ≤ x ≤ 1.5.
IOceanTidesDataProvider - Interface in org.orekit.forces.gravity.tides
Interface that provides ocean tides inputs.
IonosphericCorrection - Interface in fr.cnes.sirius.patrius.signalpropagation.iono
Interface for all the signal propagation corrections due to the ionosphere : computation of the electronic content.
IOrbitalParameters - Interface in org.orekit.orbits.orbitalparameters
Interface for orbital parameters.
IOrientationLaw - Interface in org.orekit.attitudes
This interface represents an orientation law, i.e.
IParamDiffFunction - Interface in org.orekit.parameter
This class is used to define a derivative function parameterizable.
IParameterizable - Interface in org.orekit.parameter
This interface is used to handle a list of parameterizable parameters.
IParameterizableFunction - Interface in org.orekit.parameter
This class is used to define a parameterizable function.
IPart - Interface in fr.cnes.sirius.patrius.assembly
-Interface for the assembly's parts.
IPartProperty - Interface in fr.cnes.sirius.patrius.assembly
Interface for the assembly's part properties.
IProjection - Interface in fr.cnes.sirius.patrius.projections
Interface for projections on an ellipsoid.
iRm1 - Variable in class org.apache.commons.math3.random.AbstractWell
Index indirection table giving for each index its predecessor taking table size into account.
iRm2 - Variable in class org.apache.commons.math3.random.AbstractWell
Index indirection table giving for each index its second predecessor taking table size into account.
ISAACRandom - Class in org.apache.commons.math3.random
ISAAC: a fast cryptographic pseudo-random number generator
ISAAC (Indirection, Shift, Accumulate, Add, and Count) generates 32-bit random numbers.
ISAACRandom() - Constructor for class org.apache.commons.math3.random.ISAACRandom
Creates a new ISAAC random number generator.
ISAACRandom(long) - Constructor for class org.apache.commons.math3.random.ISAACRandom
Creates a new ISAAC random number generator using a single long seed.
ISAACRandom(int[]) - Constructor for class org.apache.commons.math3.random.ISAACRandom
Creates a new ISAAC random number generator using an int array seed.
isAntisymmetric(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Checks if this is a antisymmetric matrix
isAntisymmetric(double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Checks if this is a antisymmetric matrix
isBiasCorrected() - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Returns true iff biasCorrected property is set to true.
isBiasCorrected() - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
 
isBiasCorrected() - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
 
isBracketing(double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Check whether the function takes opposite signs at the endpoints.
isBracketing(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check whether the interval bounds bracket a root.
isChildOf(Frame) - Method in class org.orekit.frames.Frame
Determine if a Frame is a child of another one.
isCloseToVend() - Method in class fr.cnes.sirius.patrius.fieldsofview.FieldAngularFace
 
isCloseToVstart() - Method in class fr.cnes.sirius.patrius.fieldsofview.FieldAngularFace
 
isConformal() - Method in class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
Inform the user if the direct transformation is a conformal 's one (If yes, it preserves angles).
isConformal() - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
Inform the user if the direct transformation is a conformal 's one (If yes, it preserves angles).
isConformal() - Method in interface fr.cnes.sirius.patrius.projections.IProjection
Inform the user if the direct transformation is a conformal 's one (If yes, it preserves angles).
isConformal() - Method in class fr.cnes.sirius.patrius.projections.Mercator
Inform the user if the direct transformation is a conformal 's one (If yes, it preserves angles).
isConnectedTo(ComparableInterval<T>) - Method in class org.orekit.utils.ComparableInterval
Returns true when the lower point coincides with the upper point of the input interval, and one of the two points is closed (and the other one is open).
isCounterClockWise() - Method in class org.apache.commons.math3.complex.RootsOfUnity
Returns true if RootsOfUnity.computeRoots(int) was called with a positive value of its argument n.
isDefaultValue(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Determine if this value is within epsilon of zero.
isDiagonal(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Given a threshold, is this a diagonal matrix? The method indicates if the matrix is diagonal.
isDiagonal(double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Given a threshold, is this a diagonal matrix? The method indicates if the matrix is diagonal.
isDifferentiableBy(Parameter) - Method in interface org.orekit.parameter.IParamDiffFunction
Tell if the function is differentiable by the given parameter.
isDifferentiableBy(Parameter) - Method in class org.orekit.parameter.ParamDiffFunction
Tell if the function is differentiable by the given parameter.
isDirect() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Check if the hyperplane orientation is direct.
isDirect() - Method in class org.orekit.frames.configuration.precessionnutation.IERS20032010PrecessionNutation
 
isDirect() - Method in class org.orekit.frames.configuration.precessionnutation.NoPrecessionNutation
Return computation type : direct or interpolated.
isDirect() - Method in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationCache
Return computation type : direct or interpolated.
isDirect() - Method in interface org.orekit.frames.configuration.precessionnutation.PrecessionNutationModel
Return computation type : direct or interpolated.
isDirect() - Method in class org.orekit.frames.configuration.precessionnutation.StelaPrecessionNutationModel
Return computation type : direct or interpolated.
ISearchIndex - Interface in org.apache.commons.math3.utils
Interfaces for optimized indices search algorithm.
ISearchIndex.SearchIndexIntervalConvention - Enum in org.apache.commons.math3.utils
Describes the shape of an interval.
isEmpty() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check if the instance is empty.
isEmpty(BSPTree<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Check if the sub-tree starting at a given node is empty.
isEmpty() - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Check if the instance is empty.
isEmpty() - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check if the instance is empty.
isEmpty(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Check if the sub-tree starting at a given node is empty.
isEmpty() - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Check if the instance is empty.
isEmpty() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Check if the tree is empty.
isEmpty() - Method in class org.orekit.attitudes.AttitudeLegsSequence
Returns true if the sequence is empty.
isEmpty() - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Chech if data map is empty
isEmpty() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Chech if data map is empty
isEqualTo(Rotation, double, double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Compare two rotations with respect to their axis and angle
isEqualTo(Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Compare two rotations with respect to the distance between them (see Rotation.distance(Rotation, Rotation)
isEquivalent() - Method in class fr.cnes.sirius.patrius.projections.GeneralizedFlamsteedSamson
Inform the user if the direct transformation is an equivalent 's one (If yes, it preserves surfaces).
isEquivalent() - Method in class fr.cnes.sirius.patrius.projections.IdentityProjection
Inform the user if the direct transformation is an equivalent 's one (If yes, it preserves surfaces).
isEquivalent() - Method in interface fr.cnes.sirius.patrius.projections.IProjection
Inform the user if the direct transformation is an equivalent 's one (If yes, it preserves surfaces).
isEquivalent() - Method in class fr.cnes.sirius.patrius.projections.Mercator
Inform the user if the direct transformation is an equivalent 's one (If yes, it preserves surfaces).
isFiring() - Method in class org.orekit.forces.maneuvers.ConstantThrustError
Returns maneuver status (firing or not).
isFiring() - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Returns maneuver status (firing or not).
isFiring() - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Returns maneuver status (firing or not).
isFirstIntervalInterp - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
True if it is the first interpolation on this interval.
isFormatOK(String, String) - Static method in class org.orekit.propagation.analytical.tle.TLE
Check the lines format validity.
isForward() - Method in class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
Check is integration direction is forward in date.
isForward() - Method in interface fr.cnes.sirius.patrius.propagation.sampling.multi.MultiOrekitStepInterpolator
Check is integration direction is forward in date.
isForward() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
Check is integration direction is forward in date.
isForward() - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Check if the natural integration direction is forward.
isForward() - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Check if the natural integration direction is forward.
isForward() - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Check is integration direction is forward in date.
isForward() - Method in class org.orekit.propagation.sampling.BasicStepInterpolator
Check is integration direction is forward in date.
isForward() - Method in interface org.orekit.propagation.sampling.OrekitStepInterpolator
Check is integration direction is forward in date.
isIncreasing() - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger.LoggedCodedEvent
Tells if g increases or decreases around event date.
isIncreasing() - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger.MultiLoggedCodedEvent
Tells if g increases or decreases around event date.
isIncreasing() - Method in class fr.cnes.sirius.patrius.events.multi.MultiEventsLogger.MultiLoggedEvent
Get the Increasing/decreasing status of the event.
isIncreasing() - Method in class org.orekit.propagation.events.EventsLogger.LoggedEvent
Get the Increasing/decreasing status of the event.
isInfinite() - Method in class org.apache.commons.math3.complex.Complex
Checks whether either the real or imaginary part of this complex number takes an infinite value (either Double.POSITIVE_INFINITY or Double.NEGATIVE_INFINITY) and neither part is NaN.
isInfinite() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is infinite.
isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in interface org.apache.commons.math3.geometry.Vector
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Check whether any coordinate of this vector is infinite and none are NaN.
isInfinite() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Check whether any coordinate of this vector is infinite and none are NaN.
isInfinite() - Method in class org.apache.commons.math3.linear.RealVector
Check whether any coordinate of this vector is infinite and none are NaN.
isInfinite() - Method in class org.apache.commons.math3.util.Decimal64
Returns true if this double precision number is infinite (Double.POSITIVE_INFINITY or Double.NEGATIVE_INFINITY).
isInside(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Return true if point is inside cone
isInTheField(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.AzimuthElevationField
isInTheField(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.BooleanField
isInTheField(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.CircularField
isInTheField(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.EllipticField
isInTheField(Vector3D) - Method in interface fr.cnes.sirius.patrius.fieldsofview.IFieldOfView
 
isInTheField(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.InvertField
isInTheField(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.OmnidirectionalField
Any vector being in the field, this method always return true
isInTheField(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.PyramidalField
 
isInTheField(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.RectangleField
isInTheField(Vector3D) - Method in class fr.cnes.sirius.patrius.fieldsofview.SectorField
isInvertible(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Given a threshold, is this an invertible matrix? The method indicates if the matrix is invertible.
isInvertible(double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Given a threshold, is this an invertible matrix? The method indicates if the matrix is invertible.
isJ2SquareComputed() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
Getter for the J22 computation flag.
isJ2SquareParDerComputed() - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaZonalAttraction
Getter for the J22 partial derivatives computation flag.
isLastStep - Variable in class org.apache.commons.math3.ode.AbstractIntegrator
Indicator for last step.
isLinkedToOrekitTree() - Method in class fr.cnes.sirius.patrius.assembly.MainPart
 
isLoaded() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Property indicating whether or not the distribution has been loaded.
isMainTargetInField(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Checks if the main target at least partially is in the field of view at a date
isMaskingCheck() - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
Check maskings.
isMonotonic(T[], MathArrays.OrderDirection, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that an array is monotonically increasing or decreasing.
isMonotonic(double[], MathArrays.OrderDirection, boolean) - Static method in class org.apache.commons.math3.util.MathArrays
Check that an array is monotonically increasing or decreasing.
isNaN() - Method in class org.apache.commons.math3.complex.Complex
Checks whether either or both parts of this complex number is NaN.
isNaN() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is not a number.
isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Returns true if any coordinate of this vector is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Returns true if any coordinate of this vector is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Returns true if any entry of this matrix is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Returns true if any coordinate of this vector is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Returns true if any coordinate of this vector is NaN; false otherwise
isNaN() - Method in interface org.apache.commons.math3.geometry.Vector
Returns true if any coordinate of this vector is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Check if any coordinate of this vector is NaN.
isNaN() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Check whether any coordinate of this vector is NaN.
isNaN() - Method in class org.apache.commons.math3.linear.RealVector
Check whether any coordinate of this vector is NaN.
isNaN() - Method in class org.apache.commons.math3.util.Decimal64
Returns true if this double precision number is Not-a-Number (NaN), false otherwise.
isNoIntercept() - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
 
isNonSingular() - Method in interface org.apache.commons.math3.linear.DecompositionSolver
Check if the decomposed matrix is non-singular.
isNonSingular() - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
Check if the decomposed matrix is non-singular.
isOrthogonal(double, double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Given a threshold, is this an orthogonal matrix? The method indicates if the matrix is orthogonal.
isOrthogonal(double, double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Given a threshold, is this an orthogonal matrix? The method indicates if the matrix is orthogonal.
isOrthogonal(double, double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Given a threshold, is this an orthogonal matrix? The method indicates if the matrix is orthogonal.
isParallelTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Check the instance is parallel to another line.
isPendingReset() - Method in class org.apache.commons.math3.ode.events.EventState
Check if some reset is being triggered.
isPendingReset() - Method in class org.orekit.propagation.events.EventState
Check if some reset is being triggered.
isPositiveDefinite(RealMatrix, double) - Static method in class org.orekit.orbits.Orbit
Test the positivity of a matrix.
isPowerOfTwo(long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns true if the argument is a power of two.
isPseudoInertial() - Method in class org.orekit.frames.Frame
Check if the frame is pseudo-inertial.
isPureQuaternion(double) - Method in class org.apache.commons.math3.complex.Quaternion
Checks whether the instance is a pure quaternion within a given tolerance.
isQuasiInertial() - Method in class org.orekit.frames.Frame
Deprecated. as of 6.0, replaced by Frame.isPseudoInertial()
isRandomStart() - Method in class org.apache.commons.math3.genetics.CycleCrossover
Returns whether the starting index is chosen randomly or set to zero.
isRecomputeDrag() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
 
isRestrictedToNonNegative() - Method in class org.apache.commons.math3.optim.linear.LinearOptimizer
 
isRestrictedToNonNegative() - Method in class org.apache.commons.math3.optim.linear.NonNegativeConstraint
Indicates whether all the variables must be restricted to non-negative values.
isSame(Chromosome) - Method in class org.apache.commons.math3.genetics.BinaryChromosome
 
isSame(Chromosome) - Method in class org.apache.commons.math3.genetics.Chromosome
Returns true iff another has the same representation and therefore the same fitness.
isSame(Chromosome) - Method in class org.apache.commons.math3.genetics.RandomKey
Returns true iff another is a RandomKey and encodes the same permutation.
isSatisfied(Population) - Method in class org.apache.commons.math3.genetics.FixedElapsedTime
Determine whether or not the maximum allowed time has passed.
isSatisfied(Population) - Method in class org.apache.commons.math3.genetics.FixedGenerationCount
Determine whether or not the given number of generations have passed.
isSatisfied(Population) - Method in interface org.apache.commons.math3.genetics.StoppingCondition
Determine whether or not the given population satisfies the stopping condition.
isSequence(double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Check whether the arguments form a (strictly) increasing sequence.
isSequence(double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check whether the arguments form a (strictly) increasing sequence.
isSimilarTo(Line) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Check if the instance is similar to another line.
isSimilarTo(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Check if the instance is similar to another plane.
isSizedAllowed(int) - Method in enum fr.cnes.sirius.patrius.tools.ephemerisComparator.DataType
Tells if the size is allowed
isSquare() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Is this a square matrix?
isSquare() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Is this a square matrix?
isSquare() - Method in interface org.apache.commons.math3.linear.AnyMatrix
Is this a square matrix?
isStartingEvent() - Method in class fr.cnes.sirius.patrius.events.CodedEvent
 
isStateActive(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
Tells if the event state is "active" for the given input.
isStateActive(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
Tells if the multi event state is "active" for the given input.
isStoreTimeDerivatives() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Returns flag indicating if time derivatives dE'/dt must be stored.
isStrictlyInside(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Return true if point is inside cone
isSuccessorOf(PosVelChebyshev) - Method in class org.orekit.bodies.PosVelChebyshev
Check if the instance is the exact successor of another model.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.BinomialDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.FDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.PascalDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.TDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.distribution.ZipfDistribution
Use this method to get information about whether the support is connected, i.e.
isSupportConnected() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Use this method to get information about whether the support is connected, i.e.
isSupported(String) - Method in class org.apache.commons.math3.ode.AbstractParameterizable
Check if a parameter is supported.
isSupported(String) - Method in interface org.apache.commons.math3.ode.Parameterizable
Check if a parameter is supported.
isSupported(Class<? extends DataProvider>) - Method in class org.orekit.data.DataProvidersManager
Deprecated. as of 6.0, replaced by DataProvidersManager.isSupported(DataProvider)
isSupported(DataProvider) - Method in class org.orekit.data.DataProvidersManager
Check if some provider is supported.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.FDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Deprecated. to be removed in 4.0
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.TDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Whether or not the lower bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.BetaDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.CauchyDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.ChiSquaredDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.FDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.GammaDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Deprecated. to be removed in 4.0
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.TDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.TriangularDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.distribution.WeibullDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Whether or not the upper bound of support is in the domain of the density function.
isSymmetric() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Checks if this is a symmetric matrix
isSymmetric(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
 
isSymmetric(RealMatrix, double) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Checks whether a matrix is symmetric.
isSymmetric() - Method in interface org.apache.commons.math3.linear.RealMatrix
Checks if this is a symmetric matrix
isSymmetric() - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Checks if this is a symmetric matrix
isTotalEclipse() - Method in class org.orekit.propagation.events.EclipseDetector
Get the total eclipse detection flag.
isTransposable() - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns true if this operator supports RealLinearOperator.operateTranspose(RealVector).
isTriggered() - Method in class org.orekit.propagation.events.NullMassDetector
Returns true if detector has been triggered.
isUnitQuaternion(double) - Method in class org.apache.commons.math3.complex.Quaternion
Checks whether the instance is a unit quaternion within a given tolerance.
isWellFormed() - Method in enum org.apache.commons.math3.geometry.euclidean.twod.EnumPolygon
A well formed polygon is CONCAVE or CONVEX
isZero() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is equal to zero.
ITargetDirection - Interface in org.orekit.attitudes.directions
This interface extends Directions for the directions described by a target point.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated. Compute the next simplex of the algorithm.
iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated. Compute the next simplex of the algorithm.
IterationEvent - Class in org.apache.commons.math3.util
The root class from which all events occurring while running an IterationManager should be derived.
IterationEvent(Object, int) - Constructor for class org.apache.commons.math3.util.IterationEvent
Creates a new instance of this class.
IterationListener - Interface in org.apache.commons.math3.util
The listener interface for receiving events occurring in an iterative algorithm.
IterationManager - Class in org.apache.commons.math3.util
This abstract class provides a general framework for managing iterative algorithms.
IterationManager(int) - Constructor for class org.apache.commons.math3.util.IterationManager
Creates a new instance of this class.
IterationManager(int, Incrementor.MaxCountExceededCallback) - Constructor for class org.apache.commons.math3.util.IterationManager
Creates a new instance of this class.
iterationPerformed(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
Invoked each time an iteration is completed (in the main iteration loop).
iterations - Variable in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
The iteration count.
iterations - Variable in class org.apache.commons.math3.optim.BaseOptimizer
Iterations counter.
iterationStarted(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
Invoked each time a new iteration is completed (in the main iteration loop).
IterativeLegendreGaussIntegrator - Class in org.apache.commons.math3.analysis.integration
This algorithm divides the integration interval into equally-sized sub-interval and on each of them performs a Legendre-Gauss quadrature.
IterativeLegendreGaussIntegrator(int, double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.IterativeLegendreGaussIntegrator
Builds an integrator with given accuracies and iterations counts.
IterativeLegendreGaussIntegrator(int, double, double) - Constructor for class org.apache.commons.math3.analysis.integration.IterativeLegendreGaussIntegrator
Builds an integrator with given accuracies.
IterativeLegendreGaussIntegrator(int, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.IterativeLegendreGaussIntegrator
Builds an integrator with given iteration counts.
IterativeLinearSolver - Class in org.apache.commons.math3.linear
This abstract class defines an iterative solver for the linear system A · x = b.
IterativeLinearSolver(int) - Constructor for class org.apache.commons.math3.linear.IterativeLinearSolver
Creates a new instance of this class, with default iteration manager.
IterativeLinearSolver(IterationManager) - Constructor for class org.apache.commons.math3.linear.IterativeLinearSolver
Creates a new instance of this class, with custom iteration manager.
IterativeLinearSolverEvent - Class in org.apache.commons.math3.linear
This is the base class for all events occuring during the iterations of a IterativeLinearSolver.
IterativeLinearSolverEvent(Object, int) - Constructor for class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Creates a new instance of this class.
iterator() - Method in class org.apache.commons.math3.genetics.ListPopulation
Returns an iterator over the unmodifiable list of chromosomes.
iterator() - Method in class org.apache.commons.math3.linear.RealVector
Generic dense iterator.
iterator() - Method in class org.apache.commons.math3.util.Combinations
iterator() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
Create an iterator over this counter.
iterator() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Get an iterator over map elements.
iterator() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Get an iterator over map elements.
iterator() - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
iterator() - Method in class org.orekit.frames.configuration.eop.NoEOP2000History
Iterator.
ITerrestrialTidesDataProvider - Interface in org.orekit.forces.gravity.tides
Interface that provides terrestrial tides inputs.
ITRF00TO93 - Static variable in class org.orekit.frames.transformations.HelmertTransformationFactory
Helmert transformation between ITRF2000 and ITRF93.
// see ftp://itrf.ensg.ign.fr/pub/itrf/ITRF.TP
// -------------------------------------------------------------------------------------
// SOLUTION T1 T2 T3 D R1 R2 R3 EPOCH Ref.
// UNITS----------> cm cm cm ppb .001" .001" .001" IERS Tech.
// .
ITRF00TO97 - Static variable in class org.orekit.frames.transformations.HelmertTransformationFactory
Helmert transformation between ITRF2000 and ITRF97
see ftp://itrf.ensg.ign.fr/pub/itrf/ITRF.TP
-------------------------------------------------------------------------------------
SOLUTION T1 T2 T3 D R1 R2 R3 EPOCH Ref.
UNITS----------> cm cm cm ppb .001" .001" .001" IERS Tech.
.
ITRF05TO00 - Static variable in class org.orekit.frames.transformations.HelmertTransformationFactory
Helmert transformation between ITRF2005 and ITRF 2000.
see http://itrf.ign.fr/ITRF_solutions/2005/tp_05-00.php

T1 T2 T3 D R1 R2 R3
mm mm mm 10-9 mas mas mas
0.1 -0.8 -5.8 0.40 0.000 0.000 0.000
+/- 0.3 0.3 0.3 0.05 0.012 0.012 0.012

Rates -0.2 0.1 -1.8 0.08 0.000 0.000 0.000
+/- 0.3 0.3 0.3 0.05 0.012 0.012 0.012


Table 1: Transformation parameters at epoch 2000.0 and their rates from ITRF2005 to ITRF2000 (ITRF2000 minus ITRF2005)
ITRF05TO08 - Static variable in class org.orekit.frames.transformations.HelmertTransformationFactory
Helmert transformation between ITRF2005 and ITRF 2008.
see http://itrf.ign.fr/ITRF_solutions/2008/tp_08-05.php

T1 T2 T3 D R1 R2 R3
mm mm mm 10-9 mas mas mas
-0.5 -0.9 -4.7 0.94 0.000 0.000 0.000
+/- 0.2 0.2 0.2 0.03 0.008 0.008 0.008

Rates 0.3 0.0 0.0 0.00 0.000 0.000 0.000
+/- 0.2 0.2 0.2 0.03 0.008 0.008 0.008

Table 1: Transformation parameters at epoch 2005.0 and their rates from ITRF2008 to ITRF2005 (ITRF2005 minus ITRF2008)
ITRFEquinoxProvider - Class in org.orekit.frames.transformations
International Terrestrial Reference Frame, based on old equinox conventions.
ITRFEquinoxProvider() - Constructor for class org.orekit.frames.transformations.ITRFEquinoxProvider
Simple constructor.
ITRFProvider - Class in org.orekit.frames.transformations
International Terrestrial Reference Frame.
ITRFProvider() - Constructor for class org.orekit.frames.transformations.ITRFProvider
Simple constructor.
IUserEphemeris - Interface in fr.cnes.sirius.validate.mocks.ephemeris
Interface representing an user-made ephemeris container.

J

J - Static variable in class org.apache.commons.math3.complex.Quaternion
j
J2000_EPOCH - Static variable in class org.orekit.time.AbsoluteDate
J2000.0 Reference epoch: 2000-01-01T12:00:00 Terrestrial Time (not UTC).
J2000_EPOCH - Static variable in class org.orekit.time.DateComponents
J2000.0 Reference epoch: 2000-01-01.
J2DifferentialEffect - Class in org.orekit.propagation.analytical
Analytical model for J2 effect.
J2DifferentialEffect(SpacecraftState, AdapterPropagator.DifferentialEffect, boolean, PotentialCoefficientsProvider) - Constructor for class org.orekit.propagation.analytical.J2DifferentialEffect
Simple constructor.
J2DifferentialEffect(Orbit, Orbit, boolean, PotentialCoefficientsProvider) - Constructor for class org.orekit.propagation.analytical.J2DifferentialEffect
Simple constructor.
J2DifferentialEffect(SpacecraftState, AdapterPropagator.DifferentialEffect, boolean, double, double, double) - Constructor for class org.orekit.propagation.analytical.J2DifferentialEffect
Simple constructor.
J2DifferentialEffect(Orbit, Orbit, boolean, double, double, double) - Constructor for class org.orekit.propagation.analytical.J2DifferentialEffect
Simple constructor.
J2SecularPropagator - Class in org.orekit.propagation.analytical
J2 secular propagator.
J2SecularPropagator(Orbit, double, double, double, Frame) - Constructor for class org.orekit.propagation.analytical.J2SecularPropagator
Constructor without attitude provider and mass provider.
J2SecularPropagator(Orbit, double, double, double, Frame, MassProvider) - Constructor for class org.orekit.propagation.analytical.J2SecularPropagator
Constructor without attitude provider.
J2SecularPropagator(Orbit, double, double, double, Frame, AttitudeProvider) - Constructor for class org.orekit.propagation.analytical.J2SecularPropagator
Constructor without mass provider.
J2SecularPropagator(Orbit, double, double, double, Frame, AttitudeProvider, AttitudeProvider) - Constructor for class org.orekit.propagation.analytical.J2SecularPropagator
Constructor without mass provider.
J2SecularPropagator(Orbit, double, double, double, Frame, AttitudeProvider, MassProvider) - Constructor for class org.orekit.propagation.analytical.J2SecularPropagator
Generic constructor.
J2SecularPropagator(Orbit, double, double, double, Frame, AttitudeProvider, AttitudeProvider, MassProvider) - Constructor for class org.orekit.propagation.analytical.J2SecularPropagator
Generic constructor.
jacobian() - Method in interface org.apache.commons.math3.analysis.DifferentiableMultivariateVectorFunction
Deprecated. Returns the jacobian function.
JacobianConverter - Class in fr.cnes.sirius.patrius.stela.orbits
Jacobian matrix converter: it is used to get Jacobian matrix from some equinoctial parameters to cartesian parameters
JacobianFunction - Class in org.apache.commons.math3.analysis.differentiation
Class representing the Jacobian of a multivariate vector function.
JacobianFunction(MultivariateDifferentiableVectorFunction) - Constructor for class org.apache.commons.math3.analysis.differentiation.JacobianFunction
Simple constructor.
JacobianMatrices - Class in org.apache.commons.math3.ode
This class defines a set of secondary equations to compute the Jacobian matrices with respect to the initial state vector and, if any, to some parameters of the primary ODE set.
JacobianMatrices(FirstOrderDifferentialEquations, double[], String...) - Constructor for class org.apache.commons.math3.ode.JacobianMatrices
Simple constructor for a secondary equations set computing Jacobian matrices.
JacobianMatrices(MainStateJacobianProvider, String...) - Constructor for class org.apache.commons.math3.ode.JacobianMatrices
Simple constructor for a secondary equations set computing Jacobian matrices.
JacobianMatrices.MismatchedEquations - Exception in org.apache.commons.math3.ode
Special exception for equations mismatch.
JacobianMatrices.MismatchedEquations() - Constructor for exception org.apache.commons.math3.ode.JacobianMatrices.MismatchedEquations
Simple constructor.
JacobianMultivariateVectorOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector
Base class for implementing optimizers for multivariate vector differentiable functions.
JacobianMultivariateVectorOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.JacobianMultivariateVectorOptimizer
 
JacobianParametersProvider - Interface in org.orekit.propagation.numerical
Interface for classes that can provide parameters for computing jacobians.
JacobiansMapper - Class in org.orekit.propagation.numerical
Mapper between two-dimensional Jacobian matrices and one-dimensional additional state arrays.
JacobiansParameterizable - Class in org.orekit.parameter
Abstract class to define generic function of IJacobiansParameterizable.
JacobiansParameterizable() - Constructor for class org.orekit.parameter.JacobiansParameterizable
Simple constructor.
JacobiansParameterizable(Parameter...) - Constructor for class org.orekit.parameter.JacobiansParameterizable
Simple constructor.
JacobiansParameterizable(ArrayList<Parameter>) - Constructor for class org.orekit.parameter.JacobiansParameterizable
Simple constructor.
JacobiansParameterizable(IParamDiffFunction...) - Constructor for class org.orekit.parameter.JacobiansParameterizable
Simple constructor.
JacobiPreconditioner - Class in org.apache.commons.math3.linear
This class implements the standard Jacobi (diagonal) preconditioner.
JacobiPreconditioner(double[], boolean) - Constructor for class org.apache.commons.math3.linear.JacobiPreconditioner
Creates a new instance of this class.
JAVA_EPOCH - Static variable in class org.orekit.time.AbsoluteDate
Java Reference epoch: 1970-01-01T00:00:00 Universal Time Coordinate is equivalent to Java Reference epoch: 1970-01-01T00:00:08 TAI.
JAVA_EPOCH - Static variable in class org.orekit.time.DateComponents
Java Reference epoch: 1970-01-01.
JavaMathAdapter - Class in fr.cnes.sirius.patrius.stela
Math adapter class.
JB2006 - Class in org.orekit.forces.atmospheres
This is the realization of the Jacchia-Bowman 2006 atmospheric model.
JB2006(JB2006InputParameters, PVCoordinatesProvider, BodyShape) - Constructor for class org.orekit.forces.atmospheres.JB2006
Constructor with space environment information for internal computation.
JB2006InputParameters - Interface in org.orekit.forces.atmospheres
Interface for solar activity and magnetic activity data.
JDKRandomGenerator - Class in org.apache.commons.math3.random
Extension of java.util.Random to implement RandomGenerator.
JDKRandomGenerator() - Constructor for class org.apache.commons.math3.random.JDKRandomGenerator
 
JPL_SSD_ASTRONOMICAL_UNIT - Static variable in interface org.orekit.utils.Constants
Astronomical Unit: 149597870691 m.
JPL_SSD_EARTH_GM - Static variable in interface org.orekit.utils.Constants
Earth attraction coefficient (m3/s2).
JPL_SSD_EARTH_MOON_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Earth/Moon mass ratio: 81.30059.
JPL_SSD_EARTH_PLUS_MOON_GM - Static variable in interface org.orekit.utils.Constants
Sun/(Earth + Moon) attraction coefficient (m3/s2).
JPL_SSD_GAUSSIAN_GRAVITATIONAL_CONSTANT - Static variable in interface org.orekit.utils.Constants
Gaussian gravitational constant: 0.01720209895 √(AU3/d2).
JPL_SSD_JUPITER_SYSTEM_GM - Static variable in interface org.orekit.utils.Constants
Sun/(Jupiter system) ttraction coefficient (m3/s2).
JPL_SSD_MARS_SYSTEM_GM - Static variable in interface org.orekit.utils.Constants
Sun/(Mars system) attraction coefficient (m3/s2).
JPL_SSD_MERCURY_GM - Static variable in interface org.orekit.utils.Constants
Sun/Mercury attraction coefficient (m3/s2).
JPL_SSD_MOON_GM - Static variable in interface org.orekit.utils.Constants
Moon attraction coefficient (m3/s2).
JPL_SSD_NEPTUNE_SYSTEM_GM - Static variable in interface org.orekit.utils.Constants
Sun/(Neptune system) attraction coefficient (m3/s2).
JPL_SSD_PLUTO_SYSTEM_GM - Static variable in interface org.orekit.utils.Constants
Sun/(Pluto system) ttraction coefficient (m3/s2).
JPL_SSD_SATURN_SYSTEM_GM - Static variable in interface org.orekit.utils.Constants
Sun/(Saturn system) attraction coefficient (m3/s2).
JPL_SSD_SUN_EARTH_PLUS_MOON_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Sun/(Earth + Moon) mass ratio: 328900.56.
JPL_SSD_SUN_GM - Static variable in interface org.orekit.utils.Constants
Sun attraction coefficient (m3/s2).
JPL_SSD_SUN_JUPITER_SYSTEM_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Sun/(Jupiter system) mass ratio: 1047.3486.
JPL_SSD_SUN_MARS_SYSTEM_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Sun/(Mars system) mass ratio: 3098708.0.
JPL_SSD_SUN_MERCURY_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Sun/Mercury mass ratio: 6023600.
JPL_SSD_SUN_NEPTUNE_SYSTEM_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Sun/(Neptune system) mass ratio: 19412.24.
JPL_SSD_SUN_PLUTO_SYSTEM_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Sun/(Pluto system) mass ratio: 1.35e8.
JPL_SSD_SUN_SATURN_SYSTEM_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Sun/(Saturn system) mass ratio: 3497.898.
JPL_SSD_SUN_URANUS_SYSTEM_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Sun/(Uranus system) mass ratio: 22902.98.
JPL_SSD_SUN_VENUS_MASS_RATIO - Static variable in interface org.orekit.utils.Constants
Sun/Venus mass ratio: 408523.71.
JPL_SSD_URANUS_SYSTEM_GM - Static variable in interface org.orekit.utils.Constants
Sun/(Uranus system) attraction coefficient (m3/s2).
JPL_SSD_VENUS_GM - Static variable in interface org.orekit.utils.Constants
Sun/Venus attraction coefficient (m3/s2).
JPLEphemeridesLoader - Class in org.orekit.bodies
Loader for JPL ephemerides binary files (DE 4xx) and similar formats (INPOP 06/08/10).
JPLEphemeridesLoader(String, JPLEphemeridesLoader.EphemerisType) - Constructor for class org.orekit.bodies.JPLEphemeridesLoader
Create a loader for JPL ephemerides binary files.
JPLEphemeridesLoader.EphemerisType - Enum in org.orekit.bodies
List of supported ephemerides types.
JQNUMTools - Class in fr.cnes.sirius.validate.jqnum
JQNUM tools
JQNUMTools(String) - Constructor for class fr.cnes.sirius.validate.jqnum.JQNUMTools
Constructor for JQNUM main
JQNUMTools() - Constructor for class fr.cnes.sirius.validate.jqnum.JQNUMTools
Constructor JQNUMTools for tested main
JQNUMTools.Rule - Enum in fr.cnes.sirius.validate.jqnum
List of JQNUM rules
JQNUMTools.TypeStrategy - Enum in fr.cnes.sirius.validate.jqnum
List of type strategies
JULIAN_CENTURY - Static variable in interface org.orekit.utils.Constants
Duration of a julian century: 36525 Constants.JULIAN_DAY.
JULIAN_DAY - Static variable in interface org.orekit.utils.Constants
Duration of a mean solar day: 86400.0 s.
JULIAN_DAY_CENTURY - Static variable in interface org.orekit.utils.Constants
Number of julian days in a century.
JULIAN_EPOCH - Static variable in class org.orekit.time.AbsoluteDate
Reference epoch for julian dates: -4712-01-01T12:00:00 Terrestrial Time.
JULIAN_EPOCH - Static variable in class org.orekit.time.DateComponents
Reference epoch for julian dates: -4712-01-01.
JULIAN_YEAR - Static variable in interface org.orekit.utils.Constants
Duration of a julian year: 365.25 Constants.JULIAN_DAY.
JUPITER - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Jupiter.

K

K - Static variable in class org.apache.commons.math3.complex.Quaternion
k
K0_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
Parameter name for K0 coefficient.
K0ALBEDO_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
Parameter name for K0 albedo global coefficient.
K0IR_COEFFICIENT - Static variable in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
Parameter name for K0 infrared global coefficient.
K_COEFFICIENT - Static variable in class org.orekit.forces.drag.DragForce
Parameter name for k coefficient.
KalmanFilter - Class in org.apache.commons.math3.filter
Implementation of a Kalman filter to estimate the state xk of a discrete-time controlled process that is governed by the linear stochastic difference equation:
KalmanFilter(ProcessModel, MeasurementModel) - Constructor for class org.apache.commons.math3.filter.KalmanFilter
Creates a new Kalman filter with the given process and measurement models.
KDB - Static variable in class fr.cnes.sirius.patrius.assembly.models.RFLinkBudgetModel
Boltzmann constant [dBW / Hz / K].
kepEq(double, double) - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Implementation of a Kepler Equation Solver described by F.
KeplerianOrbit - Class in org.orekit.orbits
This class handles traditional keplerian orbital parameters.
KeplerianOrbit(IOrbitalParameters, Frame, AbsoluteDate) - Constructor for class org.orekit.orbits.KeplerianOrbit
Creates a new instance.
KeplerianOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.KeplerianOrbit
Creates a new instance.
KeplerianOrbit(double, double, double, double, double, double, int, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.KeplerianOrbit
Deprecated. as of 6.0 replaced by KeplerianOrbit.KeplerianOrbit(double, double, double, double, double, double, PositionAngle, Frame, AbsoluteDate, double)
KeplerianOrbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.KeplerianOrbit
Constructor from cartesian parameters.
KeplerianOrbit(Orbit) - Constructor for class org.orekit.orbits.KeplerianOrbit
Constructor from any kind of orbital parameters.
KeplerianParameters - Class in org.orekit.orbits.orbitalparameters
This class handles traditional keplerian orbital parameters.
KeplerianParameters(double, double, double, double, double, double, PositionAngle, double) - Constructor for class org.orekit.orbits.orbitalparameters.KeplerianParameters
Creates a new instance.
KeplerianPropagator - Class in org.orekit.propagation.analytical
Simple keplerian orbit propagator.
KeplerianPropagator(Orbit) - Constructor for class org.orekit.propagation.analytical.KeplerianPropagator
Build a propagator from orbit only.
KeplerianPropagator(Orbit, double) - Constructor for class org.orekit.propagation.analytical.KeplerianPropagator
Build a propagator from orbit and central attraction coefficient μ.
KeplerianPropagator(Orbit, AttitudeProvider) - Constructor for class org.orekit.propagation.analytical.KeplerianPropagator
Build a propagator from orbit and a single attitude provider.
KeplerianPropagator(Orbit, AttitudeProvider, AttitudeProvider) - Constructor for class org.orekit.propagation.analytical.KeplerianPropagator
Build a propagator from orbit and attitude provider for forces and event computation.
KeplerianPropagator(Orbit, AttitudeProvider, double) - Constructor for class org.orekit.propagation.analytical.KeplerianPropagator
Build a propagator from orbit, a single attitude provider and central attraction coefficient μ.
KeplerianPropagator(Orbit, AttitudeProvider, AttitudeProvider, double) - Constructor for class org.orekit.propagation.analytical.KeplerianPropagator
Build a propagator from orbit, attitude provider for forces and events computation and central attraction coefficient μ.
KeplerianPropagator(Orbit, AttitudeProvider, double, MassProvider) - Constructor for class org.orekit.propagation.analytical.KeplerianPropagator
Build propagator from orbit, attitude provider, central attraction coefficient μ and mass.
KeplerianPropagator(Orbit, AttitudeProvider, AttitudeProvider, double, MassProvider) - Constructor for class org.orekit.propagation.analytical.KeplerianPropagator
Build propagator from orbit, attitude provider, central attraction coefficient μ and mass.
key() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
Get the key of current entry.
key() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
Get the key of current entry.
KinematicsToolkit - Class in org.orekit.attitudes.kinematics
This class contains static methods performing kinematics operations.
KinematicsToolkit.IntegrationType - Enum in org.orekit.attitudes.kinematics
Integration types.
KMeansPlusPlusClusterer<T extends Clusterable<T>> - Class in org.apache.commons.math3.stat.clustering
Clustering algorithm based on David Arthur and Sergei Vassilvitski k-means++ algorithm.
KMeansPlusPlusClusterer(Random) - Constructor for class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
Build a clusterer.
KMeansPlusPlusClusterer(Random, KMeansPlusPlusClusterer.EmptyClusterStrategy) - Constructor for class org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer
Build a clusterer.
KMeansPlusPlusClusterer.EmptyClusterStrategy - Enum in org.apache.commons.math3.stat.clustering
Strategies to use for replacing an empty cluster.
KnockeRiesModel - Class in org.orekit.forces.radiation
 
KnockeRiesModel() - Constructor for class org.orekit.forces.radiation.KnockeRiesModel
 
KolmogorovSmirnovDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Kolmogorov-Smirnov distribution.
KolmogorovSmirnovDistribution(int) - Constructor for class org.apache.commons.math3.distribution.KolmogorovSmirnovDistribution
 
kpToAp(double) - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityToolbox
Convert a single kp coefficient to a ap coefficient
kpToAp(double[]) - Static method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityToolbox
Convert an array
Kurtosis - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the Kurtosis of the available values.
Kurtosis() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Construct a Kurtosis
Kurtosis(FourthMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Construct a Kurtosis from an external moment
Kurtosis(Kurtosis) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Copy constructor, creates a new Kurtosis identical to the original

L

LagrangeEphemeris - Class in org.orekit.propagation.precomputed
Deprecated. 
LagrangeEphemeris(PVCoordinatesProvider, AttitudeProvider, AttitudeProvider, double, AbsoluteDateInterval, Frame, double, int) - Constructor for class org.orekit.propagation.precomputed.LagrangeEphemeris
Deprecated. Constructor using a PV coordinates provider and an AttitudeProvider to build the interpolation points.
LagrangeEphemeris(PVCoordinatesProvider, AttitudeProvider, AttitudeProvider, double, AbsoluteDateInterval, Frame, double) - Constructor for class org.orekit.propagation.precomputed.LagrangeEphemeris
Deprecated. Constructor using a PV coordinates provider and an AttitudeProvider to build the interpolation points, defaulting to 8th order for the Lagrange interpolator.
LagrangeEphemeris(SpacecraftState[]) - Constructor for class org.orekit.propagation.precomputed.LagrangeEphemeris
Deprecated. Constructor for a 8th order Lagrange interpolator.
LagrangeEphemeris(SpacecraftState[], int) - Constructor for class org.orekit.propagation.precomputed.LagrangeEphemeris
Deprecated. Constructor of class LagrangeEphemeris, used by other constructors of this class.
LagrangeEphemeris(SpacecraftState[], int, ISearchIndex) - Constructor for class org.orekit.propagation.precomputed.LagrangeEphemeris
Deprecated. Constructor of class LagrangeEphemeris, where a search index algorithm is passed on the constructor.
LagrangeEphemeris(SpacecraftState[], ISearchIndex) - Constructor for class org.orekit.propagation.precomputed.LagrangeEphemeris
Deprecated. Constructor for a 8th order Lagrange interpolator, where a search index algorithm is passed on the constructor.
laguerre(double, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Deprecated. This method should not be part of the public API: It will be made private in version 4.0.
LaguerreSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Laguerre's Method for root finding of real coefficient polynomials.
LaguerreSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Construct a solver with default accuracy (1e-6).
LaguerreSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Construct a solver.
LaguerreSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Construct a solver.
LaguerreSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Construct a solver.
lanczos(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the Lanczos approximation used to compute the gamma function.
LANCZOS_G - Static variable in class org.apache.commons.math3.special.Gamma
The value of the g constant in the Lanczos approximation, see Gamma.lanczos(double).
lastIncluded() - Method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
Returns a value indicating whether the last point should be passed to the underlying fixed step size step handler.
LatitudeDetector - Class in org.orekit.propagation.events
Detects when the spacecraft reaches a given local latitude.
LatitudeDetector(double, BodyShape, int) - Constructor for class org.orekit.propagation.events.LatitudeDetector
Constructor for the latitude detector.
LatitudeDetector(double, BodyShape, int, double, double) - Constructor for class org.orekit.propagation.events.LatitudeDetector
Constructor for the latitude detector.
LatitudeDetector(double, BodyShape, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.LatitudeDetector
Constructor for the latitude detector for both local increasing and decreasing latitude.
LatitudeDetector(double, BodyShape, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.LatitudeDetector
Constructor for the latitude detector for both local increasing and decreasing latitude.
LatitudeDetector(double, BodyShape, int, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.LatitudeDetector
Constructor for the latitude detector.
LatitudeDetector(double, BodyShape, int, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.LatitudeDetector
Constructor for the latitude detector.
lcm(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns the least common multiple of the absolute value of two numbers, using the formula lcm(a,b) = (a / gcd(a,b)) * b.
lcm(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns the least common multiple of the absolute value of two numbers, using the formula lcm(a,b) = (a / gcd(a,b)) * b.
LeastSquaresConverter - Class in org.apache.commons.math3.optim.nonlinear.scalar
This class converts vectorial objective functions to scalar objective functions when the goal is to minimize them.
LeastSquaresConverter(MultivariateVectorFunction, double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.LeastSquaresConverter
Builds a simple converter for uncorrelated residuals with identical weights.
LeastSquaresConverter(MultivariateVectorFunction, double[], double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.LeastSquaresConverter
Builds a simple converter for uncorrelated residuals with the specified weights.
LeastSquaresConverter(MultivariateVectorFunction, double[], RealMatrix) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.LeastSquaresConverter
Builds a simple converter for correlated residuals with the specified weights.
LeastSquaresConverter - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
LeastSquaresConverter(MultivariateVectorFunction, double[]) - Constructor for class org.apache.commons.math3.optimization.LeastSquaresConverter
Deprecated. Build a simple converter for uncorrelated residuals with the same weight.
LeastSquaresConverter(MultivariateVectorFunction, double[], double[]) - Constructor for class org.apache.commons.math3.optimization.LeastSquaresConverter
Deprecated. Build a simple converter for uncorrelated residuals with the specific weights.
LeastSquaresConverter(MultivariateVectorFunction, double[], RealMatrix) - Constructor for class org.apache.commons.math3.optimization.LeastSquaresConverter
Deprecated. Build a simple converter for correlated residuals with the specific weights.
legendre(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
Creates an integrator of the given order, and whose call to the integrate method will perform an integration on the natural interval [-1 , 1].
legendre(int, double, double) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
Creates an integrator of the given order, and whose call to the integrate method will perform an integration on the given interval.
LegendreGaussIntegrator - Class in org.apache.commons.math3.analysis.integration
Deprecated. As of 3.1 (to be removed in 4.0). Please use IterativeLegendreGaussIntegrator instead.
LegendreGaussIntegrator(int, double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.LegendreGaussIntegrator
Deprecated. Build a Legendre-Gauss integrator with given accuracies and iterations counts.
LegendreGaussIntegrator(int, double, double) - Constructor for class org.apache.commons.math3.analysis.integration.LegendreGaussIntegrator
Deprecated. Build a Legendre-Gauss integrator with given accuracies.
LegendreGaussIntegrator(int, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.LegendreGaussIntegrator
Deprecated. Build a Legendre-Gauss integrator with given iteration counts.
legendreHighPrecision(int) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
Creates an integrator of the given order, and whose call to the integrate method will perform an integration on the natural interval [-1 , 1].
legendreHighPrecision(int, double, double) - Method in class org.apache.commons.math3.analysis.integration.gauss.GaussIntegratorFactory
Creates an integrator of the given order, and whose call to the integrate method will perform an integration on the given interval.
LegendreHighPrecisionRuleFactory - Class in org.apache.commons.math3.analysis.integration.gauss
Factory that creates Gauss-type quadrature rule using Legendre polynomials.
LegendreHighPrecisionRuleFactory() - Constructor for class org.apache.commons.math3.analysis.integration.gauss.LegendreHighPrecisionRuleFactory
Default precision is DECIMAL128.
LegendreHighPrecisionRuleFactory(MathContext) - Constructor for class org.apache.commons.math3.analysis.integration.gauss.LegendreHighPrecisionRuleFactory
 
LegendreRuleFactory - Class in org.apache.commons.math3.analysis.integration.gauss
Factory that creates Gauss-type quadrature rule using Legendre polynomials.
LegendreRuleFactory() - Constructor for class org.apache.commons.math3.analysis.integration.gauss.LegendreRuleFactory
 
LenseThirringRelativisticEffect - Class in org.orekit.forces.relativistic
Computation of the relativistic Lense-Thirring effect - IERS2003 standard (applies to Earth only).
LenseThirringRelativisticEffect(double, Frame, boolean, boolean) - Constructor for class org.orekit.forces.relativistic.LenseThirringRelativisticEffect
Constructor.
LenseThirringRelativisticEffect(double, Frame) - Constructor for class org.orekit.forces.relativistic.LenseThirringRelativisticEffect
Constructor and with partial derivative computation by default.
lerp(Rotation, Rotation, double) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Returns linear interpolated rotation.
lessThan(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is less than x.
LevenbergMarquardtOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector.jacobian
This class solves a least-squares problem using the Levenberg-Marquardt algorithm.
LevenbergMarquardtOptimizer() - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Build an optimizer for least squares problems with default values for all the tuning parameters (see the other contructor.
LevenbergMarquardtOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Constructor that allows the specification of a custom convergence checker.
LevenbergMarquardtOptimizer(double, ConvergenceChecker<PointVectorValuePair>, double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Constructor that allows the specification of a custom convergence checker, in addition to the standard ones.
LevenbergMarquardtOptimizer(double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
Build an optimizer for least squares problems with default values for some of the tuning parameters (see the other contructor.
LevenbergMarquardtOptimizer(double, double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.jacobian.LevenbergMarquardtOptimizer
The arguments control the behaviour of the default convergence checking procedure.
LevenbergMarquardtOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated. As of 3.1 (to be removed in 4.0).
LevenbergMarquardtOptimizer() - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated. Build an optimizer for least squares problems with default values for all the tuning parameters (see the other contructor.
LevenbergMarquardtOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated. Constructor that allows the specification of a custom convergence checker.
LevenbergMarquardtOptimizer(double, ConvergenceChecker<PointVectorValuePair>, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated. Constructor that allows the specification of a custom convergence checker, in addition to the standard ones.
LevenbergMarquardtOptimizer(double, double, double) - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated. Build an optimizer for least squares problems with default values for some of the tuning parameters (see the other contructor.
LevenbergMarquardtOptimizer(double, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.general.LevenbergMarquardtOptimizer
Deprecated. The arguments control the behaviour of the default convergence checking procedure.
LevenbergMarquardtOrbitConverter - Class in org.orekit.propagation.analytical.tle
Orbit converter for Two-Lines Elements using differential algorithm.
LevenbergMarquardtOrbitConverter(int, int, char, int, int, String, int, int) - Constructor for class org.orekit.propagation.analytical.tle.LevenbergMarquardtOrbitConverter
Simple constructor.
LIBRATION_IERS2010 - Static variable in class org.orekit.frames.configuration.libration.LibrationCorrectionModelFactory
IERS 2010.
LibrationCorrectionModel - Interface in org.orekit.frames.configuration.libration
This interface provides the pole corrections as well as the ut1-utc corrections due to libration.
LibrationCorrectionModelFactory - Class in org.orekit.frames.configuration.libration
Factory for predefined models.
Line - Class in org.apache.commons.math3.geometry.euclidean.threed
The class represent lines in a three dimensional space.
Line(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Line
Build a line from two points.
Line(Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Line
Copy constructor.
Line - Class in org.apache.commons.math3.geometry.euclidean.twod
This class represents an oriented line in the 2D plane.
Line(Vector2D, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Line
Build a line from two points.
Line(Vector2D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Line
Build a line from a point and an angle.
Line(Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Line
Copy constructor.
linearCombination(DerivativeStructure[], DerivativeStructure[]) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double[], DerivativeStructure[]) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double, DerivativeStructure, double, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure, double, DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute a linear combination.
linearCombination(double, double[], int, double, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute linear combination.
linearCombination(double, double[], int, double, double[], int, double, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute linear combination.
linearCombination(double, double[], int, double, double[], int, double, double[], int, double, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute linear combination.
linearCombination(T[], T[]) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(double[], T[]) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(T, T, T, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(double, T, double, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(T, T, T, T, T, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(double, T, double, T, double, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(T, T, T, T, T, T, T, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(double, T, double, T, double, T, double, T) - Method in interface org.apache.commons.math3.RealFieldElement
Compute a linear combination.
linearCombination(double[], double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Compute a linear combination accurately.
linearCombination(double, double, double, double) - Static method in class org.apache.commons.math3.util.MathArrays
Compute a linear combination accurately.
linearCombination(double, double, double, double, double, double) - Static method in class org.apache.commons.math3.util.MathArrays
Compute a linear combination accurately.
linearCombination(double, double, double, double, double, double, double, double) - Static method in class org.apache.commons.math3.util.MathArrays
Compute a linear combination accurately.
LinearConstraint - Class in org.apache.commons.math3.optim.linear
A linear constraint for a linear optimization problem.
LinearConstraint(double[], Relationship, double) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraint
Build a constraint involving a single linear equation.
LinearConstraint(RealVector, Relationship, double) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraint
Build a constraint involving a single linear equation.
LinearConstraint(double[], double, Relationship, double[], double) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraint
Build a constraint involving two linear equations.
LinearConstraint(RealVector, double, Relationship, RealVector, double) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraint
Build a constraint involving two linear equations.
LinearConstraint - Class in org.apache.commons.math3.optimization.linear
Deprecated. As of 3.1 (to be removed in 4.0).
LinearConstraint(double[], Relationship, double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated. Build a constraint involving a single linear equation.
LinearConstraint(RealVector, Relationship, double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated. Build a constraint involving a single linear equation.
LinearConstraint(double[], double, Relationship, double[], double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated. Build a constraint involving two linear equations.
LinearConstraint(RealVector, double, Relationship, RealVector, double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearConstraint
Deprecated. Build a constraint involving two linear equations.
LinearConstraintSet - Class in org.apache.commons.math3.optim.linear
Class that represents a set of linear constraints.
LinearConstraintSet(LinearConstraint...) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraintSet
Creates a set containing the given constraints.
LinearConstraintSet(Collection<LinearConstraint>) - Constructor for class org.apache.commons.math3.optim.linear.LinearConstraintSet
Creates a set containing the given constraints.
LinearFunction - Class in org.orekit.parameter
This class is used to define parameterizable linear function a(t -t0) + b.
LinearFunction(AbsoluteDate, Parameter, Parameter) - Constructor for class org.orekit.parameter.LinearFunction
Simple constructor of a linear function a * (t - t0) + b using input Parameter and initial date.
LinearFunction(AbsoluteDate, double, double) - Constructor for class org.orekit.parameter.LinearFunction
Simple constructor of a linear function a * (t - t0) + b using input constant a, b and initial date.
linearInterpolation(double, double, double) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
Interpolates lineary
LinearInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Implements a linear function for interpolation of real univariate functions.
LinearInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.LinearInterpolator
 
LinearObjectiveFunction - Class in org.apache.commons.math3.optim.linear
An objective function for a linear optimization problem.
LinearObjectiveFunction(double[], double) - Constructor for class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
 
LinearObjectiveFunction(RealVector, double) - Constructor for class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
 
LinearObjectiveFunction - Class in org.apache.commons.math3.optimization.linear
Deprecated. As of 3.1 (to be removed in 4.0).
LinearObjectiveFunction(double[], double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.  
LinearObjectiveFunction(RealVector, double) - Constructor for class org.apache.commons.math3.optimization.linear.LinearObjectiveFunction
Deprecated.  
LinearOptimizer - Class in org.apache.commons.math3.optim.linear
Base class for implementing linear optimizers.
LinearOptimizer() - Constructor for class org.apache.commons.math3.optim.linear.LinearOptimizer
Simple constructor with default settings.
LinearOptimizer - Interface in org.apache.commons.math3.optimization.linear
Deprecated. As of 3.1 (to be removed in 4.0).
LineSegment - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a line segment in 3D space, with a method to compute the shortest distance to a line.
LineSegment(Vector3D, Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.LineSegment
Build a line segment from its origin, direction and length.
ListPopulation - Class in org.apache.commons.math3.genetics
Population of chromosomes represented by a List.
ListPopulation(int) - Constructor for class org.apache.commons.math3.genetics.ListPopulation
Creates a new ListPopulation instance and initializes its inner chromosome list.
ListPopulation(List<Chromosome>, int) - Constructor for class org.apache.commons.math3.genetics.ListPopulation
Creates a new ListPopulation instance.
load(double[]) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Computes the empirical distribution from the provided array of numbers.
load(URL) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Computes the empirical distribution using data read from a URL.
load(File) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Computes the empirical distribution from the input file.
loadCelestialBody(String) - Method in interface org.orekit.bodies.CelestialBodyLoader
Load celestial body.
loadCelestialBody(String) - Method in class org.orekit.bodies.JPLEphemeridesLoader
Load celestial body.
loadData(InputStream, String) - Method in class fr.cnes.sirius.patrius.signalpropagation.iono.R12Loader
 
loadData(InputStream, String) - Method in class fr.cnes.sirius.patrius.signalpropagation.iono.USKLoader
Load data from a stream.
loadData(InputStream, String) - Method in class fr.cnes.sirius.patrius.tools.force.validation.PVEphemerisLoader
 
loadData(InputStream, String) - Method in interface org.orekit.data.DataLoader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.atmospheres.solarActivity.ACSOLFormatReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.atmospheres.solarActivity.NOAAFormatReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.gravity.potential.EGMFormatReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.gravity.potential.GRGSFormatReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.gravity.potential.ICGEMFormatReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.gravity.potential.SHMFormatReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.gravity.tides.coefficients.FES2004FormatReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.forces.gravity.variations.coefficients.GRGSRL02FormatReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.frames.configuration.eop.BulletinBFilesLoader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.frames.configuration.eop.EOP05C04FilesLoader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.frames.configuration.eop.EOP08C04FilesLoader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.frames.configuration.eop.NoEOP1980HistoryLoader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.frames.configuration.eop.RapidDataAndPredictionColumnsLoader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.frames.configuration.eop.RapidDataAndPredictionXMLLoader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.models.earth.COFFileFormatReader
 
loadData(InputStream, String) - Method in class org.orekit.models.earth.GeoMagneticModelReader
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.propagation.analytical.tle.TLESeries
Load data from a stream.
loadData(InputStream, String) - Method in class org.orekit.utils.InterpolationTableLoader
Loads an bi-variate interpolation table from the given InputStream.
loadTimeSteps() - Method in interface org.orekit.time.UTCTAILoader
Load UTC-TAI offsets entries.
loadTLEData() - Method in class org.orekit.propagation.analytical.tle.TLESeries
Load TLE data for a specified object.
loadTLEData(int) - Method in class org.orekit.propagation.analytical.tle.TLESeries
Load TLE data for a specified object.
loadTLEData(int, int, String) - Method in class org.orekit.propagation.analytical.tle.TLESeries
Load TLE data for a specified object.
Localizable - Interface in org.apache.commons.math3.exception.util
Interface for localizable strings.
LocalizedFormats - Enum in org.apache.commons.math3.exception.util
Enumeration for localized messages formats used in exceptions messages.
LocalOrbitalFrame - Class in org.orekit.frames
Class for frames moving with an orbiting satellite.
LocalOrbitalFrame(Frame, LOFType, PVCoordinatesProvider, String) - Constructor for class org.orekit.frames.LocalOrbitalFrame
Build a new instance.
LocalTime - Class in org.orekit.time
This class provides methods to compute local time.
LocalTime(PVCoordinatesProvider) - Constructor for class org.orekit.time.LocalTime
Constructor
LocalTimeDetector - Class in org.orekit.propagation.events
Detects when the local time of a spacecraft is equal to a predetermined value.
The local time is represented by the angle between the projections of the Sun and the satellite in the equatorial plane; therefore this angle is equal to zero when the local time is 12.00h and Π when the local time is 0.00h.
LocalTimeDetector(double, Frame) - Constructor for class org.orekit.propagation.events.LocalTimeDetector
Constructor for a LocalTimeDetector instance.
LocalTimeDetector(double, Frame, double, double) - Constructor for class org.orekit.propagation.events.LocalTimeDetector
Constructor for a LocalTimeDetector instance with complimentary parameters.
LocalTimeDetector(double, Frame, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.LocalTimeDetector
Constructor for a LocalTimeDetector instance with complimentary parameters.
LocalTimeDetector(double, Frame, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.LocalTimeDetector
Constructor for a LocalTimeDetector instance with complimentary parameters.
LoessInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Implements the Local Regression Algorithm (also Loess, Lowess) for interpolation of real univariate functions.
LoessInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Constructs a new LoessInterpolator with a bandwidth of LoessInterpolator.DEFAULT_BANDWIDTH, LoessInterpolator.DEFAULT_ROBUSTNESS_ITERS robustness iterations and an accuracy of {#link #DEFAULT_ACCURACY}.
LoessInterpolator(double, int) - Constructor for class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Construct a new LoessInterpolator with given bandwidth and number of robustness iterations.
LoessInterpolator(double, int, double) - Constructor for class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Construct a new LoessInterpolator with given bandwidth, number of robustness iterations and accuracy.
LofOffset - Class in org.orekit.attitudes
Attitude law defined by fixed Roll, Pitch and Yaw angles (in any order) with respect to a local orbital frame.
LofOffset(Frame) - Constructor for class org.orekit.attitudes.LofOffset
Deprecated. as of 6.0 replaced by LofOffset.LofOffset(Frame, LOFType)
LofOffset(Frame, RotationOrder, double, double, double) - Constructor for class org.orekit.attitudes.LofOffset
Deprecated. as of 6.0 replaced by LofOffset.LofOffset(Frame, LOFType, RotationOrder, double, double, double)
LofOffset(LOFType) - Constructor for class org.orekit.attitudes.LofOffset
Create a LOF-aligned attitude.
LofOffset(Frame, LOFType) - Constructor for class org.orekit.attitudes.LofOffset
Create a LOF-aligned attitude.
LofOffset(Frame, LOFType, RotationOrder, double, double, double) - Constructor for class org.orekit.attitudes.LofOffset
Creates new instance.
LofOffset(LOFType, RotationOrder, double, double, double) - Constructor for class org.orekit.attitudes.LofOffset
Creates new instance.
LofOffsetPointing - Class in org.orekit.attitudes
This class provides a default attitude provider.
LofOffsetPointing(BodyShape, AttitudeProvider, Vector3D) - Constructor for class org.orekit.attitudes.LofOffsetPointing
Creates new instance.
LOFType - Enum in org.orekit.frames
Enumerate for different types of Local Orbital Frames.
log() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Natural logarithm.
log(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute natural logarithm of a derivative structure.
Log - Class in org.apache.commons.math3.analysis.function
Natural logarithm function.
Log() - Constructor for class org.apache.commons.math3.analysis.function.Log
 
log() - Method in class org.apache.commons.math3.complex.Complex
Compute the natural logarithm of this complex number.
log(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
Returns the natural logarithm of a.
log() - Method in interface org.apache.commons.math3.RealFieldElement
Natural logarithm.
log(double) - Static method in class org.apache.commons.math3.util.FastMath
Natural logarithm.
log(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Computes the logarithm in a given base.
log10() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Base 10 logarithm.
log10(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Computes base 10 logarithm of a derivative structure.
Log10 - Class in org.apache.commons.math3.analysis.function
Base 10 logarithm function.
Log10() - Constructor for class org.apache.commons.math3.analysis.function.Log10
 
log10() - Method in class org.apache.commons.math3.dfp.Dfp
Get the exponent of the greatest power of 10 that is less than or equal to abs(this).
log10(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the base 10 logarithm.
log10K() - Method in class org.apache.commons.math3.dfp.Dfp
Get the exponent of the greatest power of 10000 that is less than or equal to the absolute value of this.
log1p() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Shifted natural logarithm.
log1p(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Computes shifted logarithm of a derivative structure.
Log1p - Class in org.apache.commons.math3.analysis.function
log(1 + p) function.
Log1p() - Constructor for class org.apache.commons.math3.analysis.function.Log1p
 
log1p() - Method in interface org.apache.commons.math3.RealFieldElement
Shifted natural logarithm.
log1p(double) - Static method in class org.apache.commons.math3.util.FastMath
Computes log(1 + x).
logBeta(double, double, double, int) - Static method in class org.apache.commons.math3.special.Beta
Deprecated. as of version 3.1, this method is deprecated as the computation of the beta function is no longer iterative; it will be removed in version 4.0. Current implementation of this method internally calls Beta.logBeta(double, double).
logBeta(double, double) - Static method in class org.apache.commons.math3.special.Beta
Returns the value of log B(p, q) for 0 ≤ x ≤ 1 and p, q > 0.
logGamma(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the value of log Γ(x) for x > 0.
logGamma1p(double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the value of log Γ(1 + x) for -0.5 ≤ x ≤ 1.5.
logInternal(Dfp[]) - Static method in class org.apache.commons.math3.dfp.DfpMath
Computes the natural log of a number between 0 and 2.
Logistic - Class in org.apache.commons.math3.analysis.function
Generalised logistic function.
Logistic(double, double, double, double, double, double) - Constructor for class org.apache.commons.math3.analysis.function.Logistic
 
Logistic.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the logit function, ordered as follows: Lower asymptote Higher asymptote
Logistic.Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Logistic.Parametric
 
Logit - Class in org.apache.commons.math3.analysis.function
Logit function.
Logit() - Constructor for class org.apache.commons.math3.analysis.function.Logit
Usual logit function, where the lower bound is 0 and the higher bound is 1.
Logit(double, double) - Constructor for class org.apache.commons.math3.analysis.function.Logit
Logit function.
Logit.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the logit function, ordered as follows: Lower bound Higher bound
Logit.Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Logit.Parametric
 
LogNormalDistribution - Class in org.apache.commons.math3.distribution
Implementation of the log-normal (gaussian) distribution.
LogNormalDistribution() - Constructor for class org.apache.commons.math3.distribution.LogNormalDistribution
Create a log-normal distribution, where the mean and standard deviation of the normally distributed natural logarithm of the log-normal distribution are equal to zero and one respectively.
LogNormalDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.LogNormalDistribution
Create a log-normal distribution using the specified scale and shape.
LogNormalDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.LogNormalDistribution
Create a log-normal distribution using the specified scale, shape and inverse cumulative distribution accuracy.
LogNormalDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.LogNormalDistribution
Creates a log-normal distribution.
LongitudeDetector - Class in org.orekit.propagation.events
Detects when the spacecraft reaches a given local longitude.
LongitudeDetector(double, Frame) - Constructor for class org.orekit.propagation.events.LongitudeDetector
Constructor for the longitude detector.
LongitudeDetector(double, Frame, double, double) - Constructor for class org.orekit.propagation.events.LongitudeDetector
Constructor for the longitude detector.
LongitudeDetector(double, Frame, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.LongitudeDetector
Constructor for the longitude detector.
LongitudeDetector(double, Frame, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.LongitudeDetector
Constructor for the longitude detector.
longValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction as a long.
longValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction as a long.
longValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a long.
lowerOrEqual(double, double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Tests if one angle is lower or equal to another after expressing them in the same interval.
lowerOrEqual(double, double) - Static method in class fr.cnes.sirius.patrius.utils.Comparators
Tests if a double is lower or equal to another with a relative comparison using a default epsilon.
lowerOrEqual(double, double, double) - Static method in class fr.cnes.sirius.patrius.utils.Comparators
Tests if a double is lower or equal to another with a relative comparison using an input epsilon.
lowerStrict(double, double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Tests if one angle is strictly lower than another after expressing them in the same interval.
lowerStrict(double, double) - Static method in class fr.cnes.sirius.patrius.utils.Comparators
Tests if a double is strictly lower than another with a relative comparison using a default epsilon.
lowerStrict(double, double, double) - Static method in class fr.cnes.sirius.patrius.utils.Comparators
Tests if a double is strictly lower than another with a relative comparison using an input epsilon.
LUDecomposition - Class in org.apache.commons.math3.linear
Calculates the LUP-decomposition of a square matrix.
LUDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.LUDecomposition
Calculates the LU-decomposition of the given matrix.
LUDecomposition(RealMatrix, double) - Constructor for class org.apache.commons.math3.linear.LUDecomposition
Calculates the LU-decomposition of the given matrix.
LyddaneLongPeriodPropagator - Class in org.orekit.propagation.analytical
Lyddane long period propagator.
LyddaneLongPeriodPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType) - Constructor for class org.orekit.propagation.analytical.LyddaneLongPeriodPropagator
Constructor without attitude provider and mass provider.
LyddaneLongPeriodPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, MassProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneLongPeriodPropagator
Constructor without attitude provider.
LyddaneLongPeriodPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, AttitudeProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneLongPeriodPropagator
Constructor without mass provider.
LyddaneLongPeriodPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, AttitudeProvider, AttitudeProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneLongPeriodPropagator
Constructor without mass provider.
LyddaneLongPeriodPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, AttitudeProvider, MassProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneLongPeriodPropagator
Generic constructor.
LyddaneLongPeriodPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, AttitudeProvider, AttitudeProvider, MassProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneLongPeriodPropagator
Generic constructor.
LyddaneSecularPropagator - Class in org.orekit.propagation.analytical
Lyddane secular propagator.
LyddaneSecularPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType) - Constructor for class org.orekit.propagation.analytical.LyddaneSecularPropagator
Constructor without attitude provider and mass provider.
LyddaneSecularPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, MassProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneSecularPropagator
Constructor without attitude provider.
LyddaneSecularPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, AttitudeProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneSecularPropagator
Constructor without mass provider.
LyddaneSecularPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, AttitudeProvider, AttitudeProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneSecularPropagator
Constructor without mass provider.
LyddaneSecularPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, AttitudeProvider, MassProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneSecularPropagator
Generic constructor.
LyddaneSecularPropagator(Orbit, double, double, double, double, double, double, Frame, ParametersType, AttitudeProvider, AttitudeProvider, MassProvider) - Constructor for class org.orekit.propagation.analytical.LyddaneSecularPropagator
Generic constructor.

M

m2 - Variable in class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
second moment of values that have been added
MagneticMoment - Class in fr.cnes.sirius.patrius.assembly.models
This class represents the magnetic moment of a Spacecraft
MagneticMoment(Vector3D) - Constructor for class fr.cnes.sirius.patrius.assembly.models.MagneticMoment
Create a magnetic moment expressed in spacecraft main frame (incl.
MagneticMomentProvider - Interface in fr.cnes.sirius.patrius.assembly.models
Interface for electromagnetic sensitive spacecraft
MagneticWrench - Class in fr.cnes.sirius.patrius.wrenches
This class represents a wrench model
MagneticWrench(MagneticMomentProvider, GeoMagneticField) - Constructor for class fr.cnes.sirius.patrius.wrenches.MagneticWrench
Constructor
main(String[]) - Static method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparatorMain
main
main(String[]) - Static method in class org.apache.commons.math3.util.FastMath
Print out contents of arrays, and check the length.
MainPart - Class in fr.cnes.sirius.patrius.assembly
-Class to manage the assembly's main part.
MainPart(String) - Constructor for class fr.cnes.sirius.patrius.assembly.MainPart
Constructor of the main part.
mainSetDimension - Variable in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Main set dimension.
MainStateJacobianProvider - Interface in org.apache.commons.math3.ode
Interface expanding first order differential equations in order to compute exactly the main state jacobian matrix for partial derivatives equations.
makeJQNUMReport() - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
makeJQNUMReport make the report file
manageStateFrame() - Method in class org.orekit.propagation.AbstractPropagator
Manage the state frame : the orbit to propagate is converted in the propagation frame.
manageStateFrame() - Method in class org.orekit.propagation.analytical.KeplerianPropagator
Manage the state frame : the orbit to propagate is converted in the propagation frame.
manageStateFrame() - Method in class org.orekit.propagation.precomputed.IntegratedEphemeris
In this class, nothing as to be done in the frame managing before propagation because propagation will be performed in Frame referenceFrame It just throws an OrekitException if this frame is non inertial or pseudo-inertial.
ManeuversSequence - Class in fr.cnes.sirius.patrius.forces.maneuvers
This class handles a sequence of different maneuvers.
The maneuvers can be continue maneuvers (with constant or variable thrust), or impulse maneuvers.
ManeuversSequence(double, double) - Constructor for class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
Constructor of the maneuvers sequence.
mannWhitneyU(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.MannWhitneyUTest
Computes the Mann-Whitney U statistic comparing mean for two independent samples possibly of different length.
MannWhitneyUTest - Class in org.apache.commons.math3.stat.inference
An implementation of the Mann-Whitney U test (also called Wilcoxon rank-sum test).
MannWhitneyUTest() - Constructor for class org.apache.commons.math3.stat.inference.MannWhitneyUTest
Create a test instance using where NaN's are left in place and ties get the average of applicable ranks.
MannWhitneyUTest(NaNStrategy, TiesStrategy) - Constructor for class org.apache.commons.math3.stat.inference.MannWhitneyUTest
Create a test instance using the given strategies for NaN's and ties.
mannWhitneyUTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.MannWhitneyUTest
Returns the asymptotic observed significance level, or p-value, associated with a Mann-Whitney U statistic comparing mean for two independent samples.
mant - Variable in class org.apache.commons.math3.dfp.Dfp
Mantissa.
map(UnivariateFunction) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Acts as if implemented as:
map(UnivariateFunction) - Method in class org.apache.commons.math3.linear.RealVector
Acts as if implemented as:
mapAdd(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map an addition operation to each entry.
mapAdd(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map an addition operation to each entry.
mapAdd(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Add a value to each entry.
mapAdd(double) - Method in class org.apache.commons.math3.linear.RealVector
Add a value to each entry.
mapAdd(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map an addition operation to each entry.
mapAddToSelf(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map an addition operation to each entry.
mapAddToSelf(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Add a value to each entry.
mapAddToSelf(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map an addition operation to each entry.
mapAddToSelf(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Add a value to each entry.
mapAddToSelf(double) - Method in class org.apache.commons.math3.linear.RealVector
Add a value to each entry.
mapAddToSelf(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map an addition operation to each entry.
mapArrayToOrbit(double[], PositionAngle, AbsoluteDate, double, Frame) - Method in enum org.orekit.orbits.OrbitType
Convert state array to orbital parameters.
mapArrayToState(double[], AbsoluteDate, OrbitType, PositionAngle, AttitudeProvider, AttitudeProvider, double, Frame, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
Extract a given SpacecraftState from the state vector.
mapArrayToStates(double[], AbsoluteDate, OrbitType, PositionAngle, Map<String, AttitudeProvider>, Map<String, AttitudeProvider>, Map<String, Double>, Map<String, Frame>) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
Convert state vector into a Map of SpacecraftState
mapAttitudeToArray() - Method in class org.orekit.attitudes.Attitude
Convert Attitude to state array.
mapDivide(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a division operation to each entry.
mapDivide(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a division operation to each entry.
mapDivide(double) - Method in class org.apache.commons.math3.linear.RealVector
Divide each entry by the argument.
mapDivide(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map a division operation to each entry.
mapDivideToSelf(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a division operation to each entry.
mapDivideToSelf(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Divide each entry by the argument.
mapDivideToSelf(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a division operation to each entry.
mapDivideToSelf(double) - Method in class org.apache.commons.math3.linear.RealVector
Divide each entry by the argument.
mapDivideToSelf(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map a division operation to each entry.
mapInv() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map the 1/x function to each entry.
mapInv() - Method in interface org.apache.commons.math3.linear.FieldVector
Map the 1/x function to each entry.
mapInv() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map the 1/x function to each entry.
mapInvToSelf() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in interface org.apache.commons.math3.linear.FieldVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map the 1/x function to each entry.
mapMultiply(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a multiplication operation to each entry.
mapMultiply(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a multiplication operation to each entry.
mapMultiply(double) - Method in class org.apache.commons.math3.linear.RealVector
Multiply each entry by the argument.
mapMultiply(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map a multiplication operation to each entry.
mapMultiplyToSelf(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a multiplication operation to each entry.
mapMultiplyToSelf(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Multiply each entry.
mapMultiplyToSelf(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a multiplication operation to each entry.
mapMultiplyToSelf(double) - Method in class org.apache.commons.math3.linear.RealVector
Multiply each entry.
mapMultiplyToSelf(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map a multiplication operation to each entry.
mapOrbitToArray() - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
Substitute for Orekit's OrbitTypes.mapOrbitToArray.
mapOrbitToArray(Orbit, PositionAngle, double[]) - Method in enum org.orekit.orbits.OrbitType
Convert orbit to state array.
mapStatesToArray(Map<String, SpacecraftState>, OrbitType, PositionAngle, double[]) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
Convert a map of SpacecraftState into a state vector.
mapStateToArray(OrbitType, PositionAngle, double[]) - Method in class org.orekit.propagation.SpacecraftState
Convert SpacecraftState to state vector.
mapSubtract(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a subtraction operation to each entry.
mapSubtract(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a subtraction operation to each entry.
mapSubtract(double) - Method in class org.apache.commons.math3.linear.RealVector
Subtract a value from each entry.
mapSubtract(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map a subtraction operation to each entry.
mapSubtractToSelf(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Map a subtraction operation to each entry.
mapSubtractToSelf(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Subtract a value from each entry.
mapSubtractToSelf(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Map a subtraction operation to each entry.
mapSubtractToSelf(double) - Method in class org.apache.commons.math3.linear.RealVector
Subtract a value from each entry.
mapSubtractToSelf(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Map a subtraction operation to each entry.
mapToSelf(UnivariateFunction) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Acts as if it is implemented as:
mapToSelf(UnivariateFunction) - Method in class org.apache.commons.math3.linear.RealVector
Acts as if it is implemented as:
MARS - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Mars.
MarshallSolarActivityFutureEstimation - Class in org.orekit.forces.atmospheres.solarActivity.specialized
This class reads and provides solar activity data needed by atmospheric models: F107 solar flux and Kp indexes.
MarshallSolarActivityFutureEstimation(String, MarshallSolarActivityFutureEstimation.StrengthLevel) - Constructor for class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Simple constructor.
MarshallSolarActivityFutureEstimation.StrengthLevel - Enum in org.orekit.forces.atmospheres.solarActivity.specialized
Strength level of activity.
MaskingDetector - Class in fr.cnes.sirius.patrius.events.sensor
Sensor masking detector.
MaskingDetector(SensorModel, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Constructor for the sensor masking detector.
MaskingDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Constructor for the sensor masking detector.
MaskingDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Constructor for the sensor masking detector.
MaskingDetector(Assembly, String, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
Constructor for the sensor masking detector.
MASS - Static variable in class org.orekit.propagation.AbstractPropagator
Default prefix for additional state provider from MassProvider.
MASS - Static variable in interface org.orekit.propagation.MassProvider
Default prefix for additional equation from MassProvider.
MASS - Static variable in class org.orekit.propagation.SpacecraftState
Default prefix for additional state representing a mass.
MassEquation - Class in fr.cnes.sirius.patrius.assembly.properties
This class represents the mass equation with a name in the form "MASS_".
MassEquation(String, MassProperty) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.MassEquation
Create a new mass equation, for a given part.
MassModel - Class in fr.cnes.sirius.patrius.assembly.models
This class represents a mass model for an assembly with parts that have mass properties.
MassModel(Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.models.MassModel
Builds a mass model from an assembly and proceed to a first mass computation.
MassProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is a part property for the PATRIUS assembly.
MassProperty(double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.MassProperty
Constructor of this property.
MassProperty(Parameter) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.MassProperty
Constructor of this property using a Parameter.
MassProvider - Interface in org.orekit.propagation
Interface for spacecraft models that provide the mass.
MASTER_MODE - Static variable in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Indicator for master mode.
MASTER_MODE - Static variable in interface org.orekit.propagation.Propagator
Indicator for master mode.
mate(AbstractListChromosome<T>, AbstractListChromosome<T>) - Method in class org.apache.commons.math3.genetics.CycleCrossover
Helper for CycleCrossover.crossover(Chromosome, Chromosome).
mate(AbstractListChromosome<T>, AbstractListChromosome<T>) - Method in class org.apache.commons.math3.genetics.OrderedCrossover
Helper for OrderedCrossover.crossover(Chromosome, Chromosome).
MathArithmeticException - Exception in org.apache.commons.math3.exception
Base class for arithmetic exceptions.
MathArithmeticException() - Constructor for exception org.apache.commons.math3.exception.MathArithmeticException
Default constructor.
MathArithmeticException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathArithmeticException
Constructor with a specific message.
MathArrays - Class in org.apache.commons.math3.util
Arrays utilities.
MathArrays.Function - Interface in org.apache.commons.math3.util
Real-valued function that operate on an array or a part of it.
MathArrays.OrderDirection - Enum in org.apache.commons.math3.util
Specification of ordering direction.
MathIllegalArgumentException - Exception in org.apache.commons.math3.exception
Base class for all preconditions violation exceptions.
MathIllegalArgumentException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathIllegalArgumentException
 
MathIllegalNumberException - Exception in org.apache.commons.math3.exception
Base class for exceptions raised by a wrong number.
MathIllegalNumberException(Localizable, Number, Object...) - Constructor for exception org.apache.commons.math3.exception.MathIllegalNumberException
Construct an exception.
MathIllegalStateException - Exception in org.apache.commons.math3.exception
Base class for all exceptions that signal a mismatch between the current state and the user's expectations.
MathIllegalStateException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathIllegalStateException
Simple constructor.
MathIllegalStateException(Throwable, Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathIllegalStateException
Simple constructor.
MathIllegalStateException() - Constructor for exception org.apache.commons.math3.exception.MathIllegalStateException
Default constructor.
MathInternalError - Exception in org.apache.commons.math3.exception
Exception triggered when something that shouldn't happen does happen.
MathInternalError() - Constructor for exception org.apache.commons.math3.exception.MathInternalError
Simple constructor.
MathInternalError(Throwable) - Constructor for exception org.apache.commons.math3.exception.MathInternalError
Simple constructor.
MathInternalError(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathInternalError
Constructor accepting a localized message.
MathParseException - Exception in org.apache.commons.math3.exception
Class to signal parse failures.
MathParseException(String, int, Class<?>) - Constructor for exception org.apache.commons.math3.exception.MathParseException
 
MathParseException(String, int) - Constructor for exception org.apache.commons.math3.exception.MathParseException
 
MathRuntimeException - Exception in org.apache.commons.math3.exception
As of release 4.0, all exceptions thrown by the Commons Math code (except NullArgumentException) inherit from this class.
MathRuntimeException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathRuntimeException
 
MathUnsupportedOperationException - Exception in org.apache.commons.math3.exception
Base class for all unsupported features.
MathUnsupportedOperationException() - Constructor for exception org.apache.commons.math3.exception.MathUnsupportedOperationException
Default constructor.
MathUnsupportedOperationException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.MathUnsupportedOperationException
 
MathUtils - Class in org.apache.commons.math3.util
Miscellaneous utility functions.
Matrix3D - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a real 3x3 matrix designed to be used in geometric calculations.
Matrix3D(double[][]) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Constructor
Needs the data to fill the matrix.
Matrix3D(RealMatrix) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Constructor
Creates a Matrix3D with a RealMatrix.
Matrix3D(Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Constructor
Builds a cross product matrix M from a vector u such as : M(u) * v = u^v
matrixAdd(double[][], double[][]) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Add 2 matrices.
MatrixDimensionMismatchException - Exception in org.apache.commons.math3.linear
Exception to be thrown when either the number of rows or the number of columns of a matrix do not match the expected values.
MatrixDimensionMismatchException(int, int, int, int) - Constructor for exception org.apache.commons.math3.linear.MatrixDimensionMismatchException
Construct an exception from the mismatched dimensions.
matrixMultiply(double[][], double[][]) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Multiply 2 matrix.
matrixToVector(double[][], double[], int) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Copy a matrix into a vector, column per column.
matrixTranspose(double[][]) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Transpose a matrix.
MatrixUtils - Class in org.apache.commons.math3.linear
A collection of static methods that operate on or return matrices.
matrixVectorMultiply(double[][], double[]) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Multiply matrix with a vector.
MAX - Static variable in class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Flag for local maximum angle detection (g decreasing).
Max - Class in org.apache.commons.math3.analysis.function
Maximum function.
Max() - Constructor for class org.apache.commons.math3.analysis.function.Max
 
Max - Class in org.apache.commons.math3.stat.descriptive.rank
Returns the maximum of the available values.
Max() - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Max
Create a Max instance
Max(Max) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Max
Copy constructor, creates a new Max identical to the original
max(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the maximum of the entries in the input array, or Double.NaN if the array is empty.
max(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the maximum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
max(int, int) - Static method in class org.apache.commons.math3.util.FastMath
Compute the maximum of two values
max(long, long) - Static method in class org.apache.commons.math3.util.FastMath
Compute the maximum of two values
max(float, float) - Static method in class org.apache.commons.math3.util.FastMath
Compute the maximum of two values
max(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the maximum of two values
MAX - Static variable in class org.orekit.propagation.events.ExtremaDistanceDetector
Flag for local maximum distance detection (g decreasing).
MAX - Static variable in class org.orekit.propagation.events.ExtremaElevationDetector
Flag for local maximum elevation detection.
MAX - Static variable in class org.orekit.propagation.events.ExtremaLatitudeDetector
Flag for local maximum latitude detection (g decreasing).
MAX - Static variable in class org.orekit.propagation.events.ExtremaLongitudeDetector
Flag for local maximum longitude detection (g decreasing).
MAX - Static variable in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Flag for local maximum angle detection (g decreasing).
MAX_EXP - Static variable in class org.apache.commons.math3.dfp.Dfp
The maximum exponent before overflow is signaled and results flushed to infinity
MAX_LATITUDE - Static variable in class fr.cnes.sirius.patrius.projections.Mercator
Maximum latitude from which a Mercator transformation can be defined.
MaxCountExceededException - Exception in org.apache.commons.math3.exception
Exception to be thrown when some counter maximum value is exceeded.
MaxCountExceededException(Number) - Constructor for exception org.apache.commons.math3.exception.MaxCountExceededException
Construct the exception.
MaxCountExceededException(Localizable, Number, Object...) - Constructor for exception org.apache.commons.math3.exception.MaxCountExceededException
Construct the exception with a specific context.
maxDate - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Max date after which simulation has to fail if exception mecanism was triggered
maxDate - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
Last date in range.
MaxEval - Class in org.apache.commons.math3.optim
Maximum number of evaluations of the function to be optimized.
MaxEval(int) - Constructor for class org.apache.commons.math3.optim.MaxEval
 
MaxIter - Class in org.apache.commons.math3.optim
Maximum number of iterations performed by an (iterative) algorithm.
MaxIter(int) - Constructor for class org.apache.commons.math3.optim.MaxIter
 
mdfft(Object, TransformType) - Method in class org.apache.commons.math3.transform.FastFourierTransformer
Deprecated. see MATH-736
Mean - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the arithmetic mean of a set of values.
Mean() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Mean
Constructs a Mean.
Mean(FirstMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Mean
Constructs a Mean with an External Moment.
Mean(Mean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Mean
Copy constructor, creates a new Mean identical to the original
mean(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the arithmetic mean of the entries in the input array, or Double.NaN if the array is empty.
mean(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
mean2osc(Orbit) - Method in class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Convert provided mean orbit into osculating elements.
mean2osc(Orbit) - Method in class org.orekit.propagation.analytical.LyddaneLongPeriodPropagator
Convert provided mean orbit into osculating elements.
mean2osc(Orbit) - Method in class org.orekit.propagation.analytical.LyddaneSecularPropagator
Convert provided mean orbit into osculating elements.
mean2osc(Orbit) - Method in interface org.orekit.propagation.MeanOsculatingElementsProvider
Convert provided mean orbit into osculating elements.
MEAN_ANOMALY - Static variable in class org.orekit.orbits.KeplerianOrbit
Deprecated. as of 6.0 replaced by PositionAngle
MEAN_LATITUDE_ARGUMENT - Static variable in class org.orekit.orbits.EquinoctialOrbit
Deprecated. as of 6.0 replaced by PositionAngle
MEAN_LONGITUDE_ARGUMENT - Static variable in class org.orekit.orbits.CircularOrbit
Deprecated. as of 6.0 replaced by PositionAngle
meanDerivative(AbsoluteDate, int, int) - Method in class org.orekit.utils.SecularAndHarmonic
Get mean derivative, truncated to first components.
meanDifference(double[], double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the mean of the (signed) differences between corresponding elements of the input arrays -- i.e., sum(sample1[i] - sample2[i]) / sample1.length.
MeaningfulData - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class is a container for meaningful data.
MeaningfulData(ArrayList<DataType>, ArrayList<int[]>, Data<Double>) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.MeaningfulData
this constructor transform raw data into a set of columns of DeviationProviders.
MeaningfulDataComparator - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class compares meaningful data in DeviationProvider form.
MeaningfulDataComparator() - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.MeaningfulDataComparator
 
MeanOsculatingElementsProvider - Interface in org.orekit.propagation
Interface for mean/osculating elements converter.
meanSecondDerivative(AbsoluteDate, int, int) - Method in class org.orekit.utils.SecularAndHarmonic
Get mean second derivative, truncated to first components.
meanValue(AbsoluteDate, int, int) - Method in class org.orekit.utils.SecularAndHarmonic
Get mean value, truncated to first components.
MeasurementModel - Interface in org.apache.commons.math3.filter
Defines the measurement model for the use with a KalmanFilter.
Median - Class in org.apache.commons.math3.stat.descriptive.rank
Returns the median of the available values.
Median() - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Median
Default constructor.
Median(Median) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Median
Copy constructor, creates a new Median identical to the original
median(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns an estimate of the median of the values in the values array.
median(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns an estimate of the median of the values in the values array, starting with the element in (0-based) position begin in the array and including length values
MeeusMoon - Class in org.orekit.bodies
This class implements the Moon ephemerides according to the algorithm of Meeus.
MeeusMoon() - Constructor for class org.orekit.bodies.MeeusMoon
Simple constructor.
MeeusMoon(int, int, int) - Constructor for class org.orekit.bodies.MeeusMoon
Simple constructor.
MeeusMoonStela - Class in fr.cnes.sirius.patrius.stela.bodies
This class implements the Moon ephemerides according to the algorithm of Meeus, it only provides the position.
MeeusMoonStela(double) - Constructor for class fr.cnes.sirius.patrius.stela.bodies.MeeusMoonStela
Simple constructor.
MeeusSun - Class in org.orekit.bodies
This class implements the Sun ephemerides according to the algorithm of Meeus, it only provides the position.
MeeusSun() - Constructor for class org.orekit.bodies.MeeusSun
Simple constructor.
MeeusSunStela - Class in fr.cnes.sirius.patrius.stela.bodies
This class implements the Sun ephemerides according to the algorithm of Meeus, it only provides the position.
MeeusSunStela() - Constructor for class fr.cnes.sirius.patrius.stela.bodies.MeeusSunStela
Simple constructor.
Mercator - Class in fr.cnes.sirius.patrius.projections
The Mercator projection is a cylindrical map projection which became the standard map projection for nautical purposes because of its ability to represent lines of constant course, known loxodromes, as straight segments.
Mercator(GeodeticPoint, ProjectionEllipsoid, double, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.projections.Mercator
Complete constructor.
Mercator(double, ProjectionEllipsoid) - Constructor for class fr.cnes.sirius.patrius.projections.Mercator
Constructor with default values : The latitude of pivot is 0 azimuth is null (no rotation) centered is false.
MERCURY - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Mercury.
merge(BSPTree<S>, BSPTree<S>, BSPTree<S>, boolean, boolean) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTree.LeafMerger
Merge a leaf node and a tree node.
merge(BSPTree<S>, BSPTree.LeafMerger<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Merge a BSP tree with the instance.
merge(Frequency) - Method in class org.apache.commons.math3.stat.Frequency
Merge another Frequency object's counts into this instance.
merge(Collection<Frequency>) - Method in class org.apache.commons.math3.stat.Frequency
Merge a Collection of Frequency objects into this instance.
MergePhenomenaCriterion - Class in fr.cnes.sirius.patrius.events.postprocessing
 
MergePhenomenaCriterion(String, double) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.MergePhenomenaCriterion
Constructor
MergePhenomenaCriterion(String, double, String) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.MergePhenomenaCriterion
Constructor
MergePhenomenaCriterion(Map<String, String>, double) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.MergePhenomenaCriterion
Constructor
MergePhenomenaCriterion(List<String>, double) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.MergePhenomenaCriterion
Constructor
MergeTimelines - Class in fr.cnes.sirius.patrius.events.postprocessing
 
MergeTimelines(Timeline) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.MergeTimelines
Constructor
mergeTo(AbsoluteDateInterval) - Method in class org.orekit.utils.AbsoluteDateInterval
Merges the interval with another interval if possible (i.e.
MersenneTwister - Class in org.apache.commons.math3.random
This class implements a powerful pseudo-random number generator developed by Makoto Matsumoto and Takuji Nishimura during 1996-1997.
MersenneTwister() - Constructor for class org.apache.commons.math3.random.MersenneTwister
Creates a new random number generator.
MersenneTwister(int) - Constructor for class org.apache.commons.math3.random.MersenneTwister
Creates a new random number generator using a single int seed.
MersenneTwister(int[]) - Constructor for class org.apache.commons.math3.random.MersenneTwister
Creates a new random number generator using an int array seed.
MersenneTwister(long) - Constructor for class org.apache.commons.math3.random.MersenneTwister
Creates a new random number generator using a single long seed.
MicrosphereInterpolatingFunction - Class in org.apache.commons.math3.analysis.interpolation
Interpolating function that implements the Microsphere Projection.
MicrosphereInterpolatingFunction(double[][], double[], int, int, UnitSphereRandomVectorGenerator) - Constructor for class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolatingFunction
 
MicrosphereInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Interpolator that implements the algorithm described in William Dudziak's MS thesis.
MicrosphereInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Create a microsphere interpolator with default settings.
MicrosphereInterpolator(int, int) - Constructor for class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolator
Create a microsphere interpolator.
midpoint(double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Compute the midpoint of two values.
midPoint(int, int) - Static method in class org.apache.commons.math3.utils.SearchIndexLibrary
Returns the index of a middle point of segment [iMin, iMax]
MidpointIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements a second order Runge-Kutta integrator for Ordinary Differential Equations.
MidpointIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.MidpointIntegrator
Simple constructor.
MillerUpdatingRegression - Class in org.apache.commons.math3.stat.regression
This class is a concrete implementation of the UpdatingMultipleLinearRegression interface.
MillerUpdatingRegression(int, boolean, double) - Constructor for class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
This is the augmented constructor for the MillerUpdatingRegression class.
MillerUpdatingRegression(int, boolean) - Constructor for class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Primary constructor for the MillerUpdatingRegression.
MIN - Static variable in class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Flag for local minimum angle detection (g increasing).
Min - Class in org.apache.commons.math3.analysis.function
Minimum function.
Min() - Constructor for class org.apache.commons.math3.analysis.function.Min
 
Min - Class in org.apache.commons.math3.stat.descriptive.rank
Returns the minimum of the available values.
Min() - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Min
Create a Min instance
Min(Min) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Min
Copy constructor, creates a new Min identical to the original
min(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the minimum of the entries in the input array, or Double.NaN if the array is empty.
min(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the minimum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
min(int, int) - Static method in class org.apache.commons.math3.util.FastMath
Compute the minimum of two values
min(long, long) - Static method in class org.apache.commons.math3.util.FastMath
Compute the minimum of two values
min(float, float) - Static method in class org.apache.commons.math3.util.FastMath
Compute the minimum of two values
min(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the minimum of two values
MIN - Static variable in class org.orekit.propagation.events.ExtremaDistanceDetector
Flag for local minimum distance detection (g increasing).
MIN - Static variable in class org.orekit.propagation.events.ExtremaElevationDetector
Flag for local minimum elevation detection.
MIN - Static variable in class org.orekit.propagation.events.ExtremaLatitudeDetector
Flag for local minimum latitude detection (g increasing).
MIN - Static variable in class org.orekit.propagation.events.ExtremaLongitudeDetector
Flag for local minimum longitude detection (g increasing).
MIN - Static variable in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Flag for local minimum angle detection (g increasing).
MIN_EXP - Static variable in class org.apache.commons.math3.dfp.Dfp
The minimum exponent before underflow is signaled.
MIN_MAX - Static variable in class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
Flag for both local minimum and maximum angle detection.
MIN_MAX - Static variable in class org.orekit.propagation.events.ExtremaDistanceDetector
Flag for both local minimum and maximum distance detection.
MIN_MAX - Static variable in class org.orekit.propagation.events.ExtremaElevationDetector
Flag for both local minimum and maximum elevation detection.
MIN_MAX - Static variable in class org.orekit.propagation.events.ExtremaLatitudeDetector
Flag for both local minimum and maximum distance detection.
MIN_MAX - Static variable in class org.orekit.propagation.events.ExtremaLongitudeDetector
Flag for both local minimum and maximum distance detection.
MIN_MAX - Static variable in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
Flag for both local minimum and maximum angle detection.
MIN_POINT_NB - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Minimum number of points to build a polygon.
minDate - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
First date in range.
MINIMUM_PROBLEM_DIMENSION - Static variable in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.BOBYQAOptimizer
Minimum dimension of the problem: 2
MINIMUM_PROBLEM_DIMENSION - Static variable in class org.apache.commons.math3.optimization.direct.BOBYQAOptimizer
Deprecated. Minimum dimension of the problem: 2
Minus - Class in org.apache.commons.math3.analysis.function
Minus function.
Minus() - Constructor for class org.apache.commons.math3.analysis.function.Minus
 
MINUS_I - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Opposite of the first canonical vector (coordinates: -1, 0, 0).
MINUS_J - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Opposite of the second canonical vector (coordinates: 0, -1, 0).
MINUS_K - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Opposite of the third canonical vector (coordinates: 0, 0, -1).
MINUS_ONE - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "-1 / 1".
MINUS_ONE - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "-1 / 1".
missingCoefficientsAllowed() - Method in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Check if missing coefficients are allowed in the input data.
MixtureMultivariateRealDistribution<T extends MultivariateRealDistribution> - Class in org.apache.commons.math3.distribution
Class for representing mixture model distributions.
MixtureMultivariateRealDistribution(List<Pair<Double, T>>) - Constructor for class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Creates a mixture model from a list of distributions and their associated weights.
MixtureMultivariateRealDistribution(RandomGenerator, List<Pair<Double, T>>) - Constructor for class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Creates a mixture model from a list of distributions and their associated weights.
mod(double, double) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Computes "x" modulo "mod".
ModeHandler - Interface in org.orekit.propagation.numerical
Common interface for all propagator mode handlers initialization.
ModelFunction - Class in org.apache.commons.math3.optim.nonlinear.vector
Model (vector) function to be optimized.
ModelFunction(MultivariateVectorFunction) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.ModelFunction
 
ModelFunctionJacobian - Class in org.apache.commons.math3.optim.nonlinear.vector
Jacobian of the model (vector) function to be optimized.
ModelFunctionJacobian(MultivariateMatrixFunction) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.ModelFunctionJacobian
 
ModelSpecificationException - Exception in org.apache.commons.math3.stat.regression
Exception thrown when a regression model is not correctly specified.
ModelSpecificationException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.stat.regression.ModelSpecificationException
 
MODIFIED_JULIAN_EPOCH - Static variable in class org.orekit.time.AbsoluteDate
Reference epoch for modified julian dates: 1858-11-17T00:00:00 Terrestrial Time.
MODIFIED_JULIAN_EPOCH - Static variable in class org.orekit.time.DateComponents
Reference epoch for modified julian dates: 1858-11-17.
MODProvider - Class in org.orekit.frames.transformations
Mean Equator, Mean Equinox Frame.
MODProvider() - Constructor for class org.orekit.frames.transformations.MODProvider
Simple constructor.
MOLECULAR_NITROGEN - Static variable in class org.orekit.forces.atmospheres.DTM2000
Identifier for molecular nitrogen.
MOLECULAR_OXYGEN - Static variable in class org.orekit.forces.atmospheres.DTM2000
Identifier for molecular oxygen.
moment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Kurtosis
Fourth Moment on which this statistic is based
moment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Mean
First moment on which this statistic is based.
moment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Skewness
Third moment on which this statistic is based
moment - Variable in class org.apache.commons.math3.stat.descriptive.moment.Variance
SecondMoment is used in incremental calculation of Variance
MomentumDirection - Class in org.orekit.attitudes.directions
Direction described by a celestial body (the reference body of the orbit).
MomentumDirection(CelestialBody) - Constructor for class org.orekit.attitudes.directions.MomentumDirection
Build a direction from the celestial body around witch the orbit is defined.
monitorDetector(CodingEventDetector) - Method in class fr.cnes.sirius.patrius.events.CodedEventsLogger
Takes a CodingEventDetector instance and returns an EventDetector instance that will trigger this CodedEventsLogger every time eventOccurred is called.
monitorDetector(MultiCodingEventDetector) - Method in class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger
Takes a MultiCodingEventDetector instance and returns an MultiEventDetector instance that will trigger this MultiCodedEventsLogger every time eventOccurred is called.
monitorDetector(MultiEventDetector) - Method in class fr.cnes.sirius.patrius.events.multi.MultiEventsLogger
Monitor a multi event detector.
monitorDetector(EventDetector) - Method in class org.orekit.propagation.events.EventsLogger
Monitor an event detector.
Month - Enum in org.orekit.time
Enumerate representing a calendar month.
MOON - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Moon.
MOON_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.Constants
Moon equatorial radius: 1737400 m.
MSIS00Adapter - Class in fr.cnes.sirius.patrius.stela.forces.atmospheres
This class implements the MSIS00 atmospheric model.
MSIS00Adapter(MSISE2000InputParameters, double, double, CelestialBody) - Constructor for class fr.cnes.sirius.patrius.stela.forces.atmospheres.MSIS00Adapter
Simple constructor for class MSIS00Adapter.
MSISE2000 - Class in org.orekit.forces.atmospheres
This class implements the MSIS00 atmospheric model.
MSISE2000(MSISE2000InputParameters, BodyShape, CelestialBody) - Constructor for class org.orekit.forces.atmospheres.MSISE2000
Simple constructor for class MSIS00Adapter.
MSISE2000InputParameters - Interface in org.orekit.forces.atmospheres
Container for solar activity data, compatible with MSISE2000 Atmosphere model.
MU - Static variable in interface org.orekit.forces.gravity.AttractionModel
Parameter name for central attraction coefficient.
mu - Variable in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Central body attraction coefficient.
MU - Static variable in class org.orekit.forces.gravity.tides.AbstractTides
Parameter name for central attraction coefficient.
mu - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
Mu.
mulAndCheck(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Multiply two integers, checking for overflow.
mulAndCheck(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Multiply two long integers, checking for overflow.
MullerSolver - Class in org.apache.commons.math3.analysis.solvers
This class implements the Muller's Method for root finding of real univariate functions.
MullerSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver
Construct a solver with default accuracy (1e-6).
MullerSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver
Construct a solver.
MullerSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver
Construct a solver.
MullerSolver2 - Class in org.apache.commons.math3.analysis.solvers
This class implements the Muller's Method for root finding of real univariate functions.
MullerSolver2() - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver2
Construct a solver with default accuracy (1e-6).
MullerSolver2(double) - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver2
Construct a solver.
MullerSolver2(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.MullerSolver2
Construct a solver.
MultiAbstractDetector - Class in fr.cnes.sirius.patrius.propagation.events.multi
This class is copied from AbstractDetector and adapted to multi propagation.
MultiAbstractDetector(double, double) - Constructor for class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
Build a new instance.
MultiAbstractDetector(int, double, double) - Constructor for class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
Build a new instance.
MultiAdaptedStepHandler - Class in fr.cnes.sirius.patrius.propagation.sampling.multi
This class is copied from AdaptedStepHandler and adapted to multi propagation.
MultiAdaptedStepHandler(MultiOrekitStepHandler) - Constructor for class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiAdaptedStepHandler
Build an instance.
MultiCodedEventsLogger - Class in fr.cnes.sirius.patrius.events.multi
This class is copied from CodedEventsLogger and adapted to multi propagation.
MultiCodedEventsLogger() - Constructor for class fr.cnes.sirius.patrius.events.multi.MultiCodedEventsLogger
Default constructor.
MultiCodedEventsLogger.MultiLoggedCodedEvent - Class in fr.cnes.sirius.patrius.events.multi
This class is used to store the coded event with contextual information.
MultiCodingEventDetector - Interface in fr.cnes.sirius.patrius.events.multi
This class is copied from CodingEventDetector and adapted to multi propagation.
MultidimensionalCounter - Class in org.apache.commons.math3.util
Converter between unidimensional storage structure and multidimensional conceptual structure.
MultidimensionalCounter(int...) - Constructor for class org.apache.commons.math3.util.MultidimensionalCounter
Create a counter.
MultidimensionalCounter.Iterator - Class in org.apache.commons.math3.util
Perform iteration over the multidimensional counter.
MultiDimensionMismatchException - Exception in org.apache.commons.math3.exception
Exception to be thrown when two sets of dimensions differ.
MultiDimensionMismatchException(Integer[], Integer[]) - Constructor for exception org.apache.commons.math3.exception.MultiDimensionMismatchException
Construct an exception from the mismatched dimensions.
MultiDimensionMismatchException(Localizable, Integer[], Integer[]) - Constructor for exception org.apache.commons.math3.exception.MultiDimensionMismatchException
Construct an exception from the mismatched dimensions.
MultiDirectionalSimplex - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This class implements the multi-directional direct search method.
MultiDirectionalSimplex(int) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(int, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(int, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(int, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(double[], double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(double[][]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(double[][], double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
MultiDirectionalSimplex(int) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated. Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(int, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated. Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(int, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated. Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(int, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated. Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(double[]) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated. Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(double[], double, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated. Build a multi-directional simplex with specified coefficients.
MultiDirectionalSimplex(double[][]) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated. Build a multi-directional simplex with default coefficients.
MultiDirectionalSimplex(double[][], double, double) - Constructor for class org.apache.commons.math3.optimization.direct.MultiDirectionalSimplex
Deprecated. Build a multi-directional simplex with specified coefficients.
MultiEphemerisModeHandler - Class in fr.cnes.sirius.patrius.propagation.numerical.multi
This interface is copied from EphemerisModeHandler and adapted to multi propagation.
MultiEphemerisModeHandler() - Constructor for class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiEphemerisModeHandler
Creates a new instance of MultiEphemerisModeHandler which must be filled by the propagator.
MultiEventDetector - Interface in org.orekit.propagation.events.multi
This interface is copied from EventDetector and adapted to multi propagation.
MultiEventsLogger - Class in fr.cnes.sirius.patrius.events.multi
This class is copied from EventsLogger and adapted to multi propagation.
MultiEventsLogger() - Constructor for class fr.cnes.sirius.patrius.events.multi.MultiEventsLogger
Simple constructor.
MultiEventsLogger.MultiLoggedEvent - Class in fr.cnes.sirius.patrius.events.multi
Class for logged events entries.
MultiGenericCodingEventDetector - Class in fr.cnes.sirius.patrius.events.multi
This class is copied from GenericCodingEventDetector and adapted to multi propagation.
MultiGenericCodingEventDetector(MultiEventDetector, String, String, boolean, String) - Constructor for class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
Constructor for a MultiGenericCodingEventDetector that supports a Phenomenon.
No delays and no occurrence numbers are associated to the events detected by this detector.
MultiGenericCodingEventDetector(MultiEventDetector, String, String, boolean, String, double, int) - Constructor for class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
Constructor for a MultiGenericCodingEventDetector that supports a Phenomenon.
A delay and/or an occurrence number can be associated to the events detected by this detector.
When a delay is added to the detected events, two kinds of events will be coded:
- the original events, with their original codes;
- the delayed events, whose codes will be "DELAYED_" followed by the original code.
MultiGenericCodingEventDetector(MultiEventDetector, String, String) - Constructor for class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
Constructor for a MultiGenericCodingEventDetector that does not support a Phenomenon.
MultiGenericCodingEventDetector(MultiEventDetector, String, String, double, int) - Constructor for class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
Constructor for a MultiGenericCodingEventDetector that does not support a Phenomenon.
When a delay is added to the detected events, two kinds of events will be coded:
- the original events, with their original codes;
- the delayed events, whose codes will be "DELAYED_" followed by the original code.
MultiIntegratedEphemeris - Class in fr.cnes.sirius.patrius.propagation.precomputed.multi
This interface is copied from IntegratedEphemeris and adapted to multi propagation.
MultiIntegratedEphemeris(List<AbsoluteDate>, List<AbsoluteDate>, List<AbsoluteDate>, OrbitType, PositionAngle, AttitudeProvider, AttitudeProvider, MultiStateVectorInfo, List<ContinuousOutputModel>, Frame, double, String) - Constructor for class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
Creates a new instance of IntegratedEphemeris.
MultiModeHandler - Interface in fr.cnes.sirius.patrius.propagation.numerical.multi
This interface is copied from ModeHandler and adapted to multi propagation.
MultiNumericalPropagator - Class in fr.cnes.sirius.patrius.propagation.numerical.multi
This class is copied from NumericalPropagator and adapted to multi propagation.
MultiNumericalPropagator(FirstOrderIntegrator) - Constructor for class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Create a new instance of MultiNumericalPropagator.
MultiOrekitFixedStepHandler - Interface in fr.cnes.sirius.patrius.propagation.sampling.multi
This interface is copied from OrekitFixedStepHandler and adapted to multi propagation.
MultiOrekitStepHandler - Interface in fr.cnes.sirius.patrius.propagation.sampling.multi
This interface is copied from OrekitStepHandler and adapted to multi propagation.
MultiOrekitStepInterpolator - Interface in fr.cnes.sirius.patrius.propagation.sampling.multi
This interface is copied from OrekitStepInterpolator and adapted to multi propagation.
MultiOrekitStepNormalizer - Class in fr.cnes.sirius.patrius.propagation.sampling.multi
This class is copied from OrekitStepNormalizer and adapted to multi propagation.
MultiOrekitStepNormalizer(double, MultiOrekitFixedStepHandler) - Constructor for class fr.cnes.sirius.patrius.propagation.sampling.multi.MultiOrekitStepNormalizer
Simple constructor.
MultipleLinearRegression - Interface in org.apache.commons.math3.stat.regression
The multiple linear regression can be represented in matrix-notation.
MULTIPLICATIVE_MODE - Static variable in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Please use ResizableDoubleArray.ExpansionMode.MULTIPLICATIVE instead.
multiply(int) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute n × this.
multiply(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'×' operator.
multiply(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'×' operator.
multiply(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform multiplication of two derivative structures.
Multiply - Class in org.apache.commons.math3.analysis.function
Multiply the two operands.
Multiply() - Constructor for class org.apache.commons.math3.analysis.function.Multiply
 
multiply(UnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Multiplies functions.
multiply(UnivariateDifferentiableFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Multiplies functions.
multiply(DifferentiableUnivariateFunction...) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated. as of 3.1 replaced by FunctionUtils.multiply(UnivariateDifferentiableFunction...)
multiply(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Multiply the instance by a polynomial.
multiply(TrigonometricPolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Multiply this polynomial by another polynomial
multiply(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is this * factor.
multiply(int) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is this * factor, with factor interpreted as a integer number.
multiply(double) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is this * factor, with factor interpreted as a real number.
multiply(Quaternion, Quaternion) - Static method in class org.apache.commons.math3.complex.Quaternion
Returns the Hamilton product of two quaternions.
multiply(Quaternion) - Method in class org.apache.commons.math3.complex.Quaternion
Returns the Hamilton product of the instance by a quaternion.
multiply(double) - Method in class org.apache.commons.math3.complex.Quaternion
Multiplies the instance by a scalar.
multiply(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Multiply this by x.
multiply(int) - Method in class org.apache.commons.math3.dfp.Dfp
Multiply this by a single digit x.
multiply(int) - Method in interface org.apache.commons.math3.FieldElement
Compute n × this.
multiply(T) - Method in interface org.apache.commons.math3.FieldElement
Compute this × a.
multiply(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
Multiplies the value of this fraction by the passed BigInteger, returning the result in reduced form.
multiply(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Multiply the value of this fraction by the passed int, returning the result in reduced form.
multiply(long) - Method in class org.apache.commons.math3.fraction.BigFraction
Multiply the value of this fraction by the passed long, returning the result in reduced form.
multiply(BigFraction) - Method in class org.apache.commons.math3.fraction.BigFraction
Multiplies the value of this fraction by another, returning the result in reduced form.
multiply(Fraction) - Method in class org.apache.commons.math3.fraction.Fraction
Multiplies the value of this fraction by another, returning the result in reduced form.
multiply(int) - Method in class org.apache.commons.math3.fraction.Fraction
Multiply the fraction by an integer.
multiply(Matrix3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Computes a matrix multiplication between two Matrix3D objects
multiply(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Computes the multiplication between a Matrix3D and a Vector3D
multiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Computes a multiplication of this Matrix3D with a scalar
multiply(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Postmultiply this matrix by m.
multiply(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of postmultiplying this by m.
multiply(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Postmultiplying this matrix by m.
multiply(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the result of postmultiplying this by m.
multiply(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Postmultiply this matrix by m.
multiply(BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of postmultiplying this by m.
multiply(BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of postmultiplying this by m.
multiply(DiagonalMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the result of postmultiplying this by m.
multiply(SymmetricMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the result of postmultiplying this by m.
multiply(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Postmultiply this matrix by m.
multiply(RealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Returns the result of postmultiplying this by m.
multiply(OpenMapRealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Postmultiply this matrix by m.
multiply(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of postmultiplying this by m.
multiply(SymmetricMatrix) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns the result of postmultiplying this by m.
multiply(DiagonalMatrix) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns the result of postmultiplying this by m.
multiply(double) - Method in interface org.apache.commons.math3.RealFieldElement
'×' operator.
multiply(BigReal) - Method in class org.apache.commons.math3.util.BigReal
Compute this × a.
multiply(int) - Method in class org.apache.commons.math3.util.BigReal
Compute n × this.
multiply(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute this × a.
multiply(int) - Method in class org.apache.commons.math3.util.Decimal64
Compute n × this.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Multiplies (in place) the specified entry of this matrix by the specified value.
MultiPropagator - Interface in fr.cnes.sirius.patrius.propagation
This interface is copied from Propagator and adapted to multi propagation.
MultiStartMultivariateOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar
Multi-start optimizer.
MultiStartMultivariateOptimizer(MultivariateOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
Create a multi-start optimizer from a single-start optimizer.
MultiStartMultivariateVectorOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector
Multi-start optimizer for a (vector) model function.
MultiStartMultivariateVectorOptimizer(MultivariateVectorOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.MultiStartMultivariateVectorOptimizer
Create a multi-start optimizer from a single-start optimizer.
MultiStartUnivariateOptimizer - Class in org.apache.commons.math3.optim.univariate
Special implementation of the UnivariateOptimizer interface adding multi-start features to an existing optimizer.
MultiStartUnivariateOptimizer(UnivariateOptimizer, int, RandomGenerator) - Constructor for class org.apache.commons.math3.optim.univariate.MultiStartUnivariateOptimizer
Create a multi-start optimizer from a single-start optimizer.
MultiStateVectorInfo - Class in fr.cnes.sirius.patrius.propagation.numerical.multi
Utility class that describes in a minimal fashion the structure of a state.
MultiStateVectorInfo(Map<String, SpacecraftState>) - Constructor for class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiStateVectorInfo
Build a MultiSatStateVectorInfo instance using the spacecraft states' map.
MultistepIntegrator - Class in org.apache.commons.math3.ode
This class is the base class for multistep integrators for Ordinary Differential Equations.
MultistepIntegrator(String, int, int, double, double, double, double) - Constructor for class org.apache.commons.math3.ode.MultistepIntegrator
Build a multistep integrator with the given stepsize bounds.
MultistepIntegrator(String, int, int, double, double, double[], double[]) - Constructor for class org.apache.commons.math3.ode.MultistepIntegrator
Build a multistep integrator with the given stepsize bounds.
MultistepIntegrator.NordsieckTransformer - Interface in org.apache.commons.math3.ode
Transformer used to convert the first step to Nordsieck representation.
MultivariateDifferentiableFunction - Interface in org.apache.commons.math3.analysis.differentiation
Extension of MultivariateFunction representing a multivariate differentiable real function.
MultivariateDifferentiableMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
MultivariateDifferentiableMultiStartOptimizer(MultivariateDifferentiableOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.MultivariateDifferentiableMultiStartOptimizer
Deprecated. Create a multi-start optimizer from a single-start optimizer.
MultivariateDifferentiableOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
MultivariateDifferentiableVectorFunction - Interface in org.apache.commons.math3.analysis.differentiation
Extension of MultivariateVectorFunction representing a multivariate differentiable vectorial function.
MultivariateDifferentiableVectorMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
MultivariateDifferentiableVectorMultiStartOptimizer(MultivariateDifferentiableVectorOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.MultivariateDifferentiableVectorMultiStartOptimizer
Deprecated. Create a multi-start optimizer from a single-start optimizer.
MultivariateDifferentiableVectorOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
MultivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a multivariate real function.
MultivariateFunctionMappingAdapter - Class in org.apache.commons.math3.optim.nonlinear.scalar
Adapter for mapping bounded MultivariateFunction to unbounded ones.
MultivariateFunctionMappingAdapter(MultivariateFunction, double[], double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
Simple constructor.
MultivariateFunctionMappingAdapter - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
MultivariateFunctionMappingAdapter(MultivariateFunction, double[], double[]) - Constructor for class org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter
Deprecated. Simple constructor.
MultivariateFunctionPenaltyAdapter - Class in org.apache.commons.math3.optim.nonlinear.scalar
Adapter extending bounded MultivariateFunction to an unbouded domain using a penalty function.
MultivariateFunctionPenaltyAdapter(MultivariateFunction, double[], double[], double, double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionPenaltyAdapter
Simple constructor.
MultivariateFunctionPenaltyAdapter - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
MultivariateFunctionPenaltyAdapter(MultivariateFunction, double[], double[], double, double[]) - Constructor for class org.apache.commons.math3.optimization.direct.MultivariateFunctionPenaltyAdapter
Deprecated. Simple constructor.
MultivariateInterpolator - Interface in org.apache.commons.math3.analysis.interpolation
Interface representing a univariate real interpolating function.
MultivariateMatrixFunction - Interface in org.apache.commons.math3.analysis
An interface representing a multivariate matrix function.
MultivariateMultiStartOptimizer - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
MultivariateMultiStartOptimizer(MultivariateOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math3.optimization.MultivariateMultiStartOptimizer
Deprecated. Create a multi-start optimizer from a single-start optimizer.
MultivariateNormalDistribution - Class in org.apache.commons.math3.distribution
Implementation of the multivariate normal (Gaussian) distribution.
MultivariateNormalDistribution(double[], double[][]) - Constructor for class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Creates a multivariate normal distribution with the given mean vector and covariance matrix.
MultivariateNormalDistribution(RandomGenerator, double[], double[][]) - Constructor for class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Creates a multivariate normal distribution with the given mean vector and covariance matrix.
MultivariateOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar
Base class for a multivariate scalar function optimizer.
MultivariateOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateOptimizer
 
MultivariateOptimizer - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
MultivariateRealDistribution - Interface in org.apache.commons.math3.distribution
Base interface for multivariate distributions on the reals.
MultivariateSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
Computes summary statistics for a stream of n-tuples added using the addValue method.
MultivariateSummaryStatistics(int, boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Construct a MultivariateSummaryStatistics instance
MultivariateVectorFunction - Interface in org.apache.commons.math3.analysis
An interface representing a multivariate vectorial function.
MultivariateVectorOptimizer - Class in org.apache.commons.math3.optim.nonlinear.vector
Base class for a multivariate vector function optimizer.
MultivariateVectorOptimizer(ConvergenceChecker<PointVectorValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.MultivariateVectorOptimizer
 
mutate(Chromosome) - Method in class org.apache.commons.math3.genetics.BinaryMutation
Mutate the given chromosome.
mutate(Chromosome) - Method in interface org.apache.commons.math3.genetics.MutationPolicy
Mutate the given chromosome.
mutate(Chromosome) - Method in class org.apache.commons.math3.genetics.RandomKeyMutation
Mutate the given chromosome.
MutationPolicy - Interface in org.apache.commons.math3.genetics
Algorithm used to mutate a chromosome.

N

NadirDirection - Class in org.orekit.attitudes.directions
Nadir direction.
NadirDirection(BodyShape) - Constructor for class org.orekit.attitudes.directions.NadirDirection
Simple constructor
NadirPointing - Class in org.orekit.attitudes
This class handles nadir pointing attitude provider.
NadirPointing(BodyShape) - Constructor for class org.orekit.attitudes.NadirPointing
Creates new instance.
NadirSolarIncidenceDetector - Class in org.orekit.propagation.events
Spacecraft's nadir point solar incidence detector.
NadirSolarIncidenceDetector(double, BodyShape, double, double) - Constructor for class org.orekit.propagation.events.NadirSolarIncidenceDetector
Constructor for the nadir point solar incidence detector
NadirSolarIncidenceDetector(double, BodyShape, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.NadirSolarIncidenceDetector
Constructor for the nadir point solar incidence detector
NadirSolarIncidenceDetector(double, BodyShape, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.NadirSolarIncidenceDetector
Constructor for the nadir point solar incidence detector
name() - Method in interface fr.cnes.sirius.validate.mocks.ephemeris.IEphemerisBody
 
NaN - Static variable in class org.apache.commons.math3.complex.Complex
A complex number representing "NaN + NaNi"
NaN - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
A vector with all coordinates set to NaN.
NaN - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
A vector with all coordinates set to NaN.
NaN - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
A vector with all coordinates set to NaN.
NAN - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of Double.NaN as a Decimal64.
nans - Variable in class org.apache.commons.math3.dfp.Dfp
Indicator for non-finite / non-number values.
NaNStrategy - Enum in org.apache.commons.math3.stat.ranking
Strategies for handling NaN values in rank transformations.
natural(int) - Static method in class org.apache.commons.math3.util.MathArrays
Returns an array representing the natural number n.
NaturalRanking - Class in org.apache.commons.math3.stat.ranking
Ranking based on the natural ordering on doubles.
NaturalRanking() - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with default strategies for handling ties and NaNs.
NaturalRanking(TiesStrategy) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with the given TiesStrategy.
NaturalRanking(NaNStrategy) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with the given NaNStrategy.
NaturalRanking(NaNStrategy, TiesStrategy) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with the given NaNStrategy and TiesStrategy.
NaturalRanking(RandomGenerator) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with TiesStrategy.RANDOM and the given RandomGenerator as the source of random data.
NaturalRanking(NaNStrategy, RandomGenerator) - Constructor for class org.apache.commons.math3.stat.ranking.NaturalRanking
Create a NaturalRanking with the given NaNStrategy, TiesStrategy.RANDOM and the given source of random data.
nDoodson(double) - Static method in class org.orekit.forces.gravity.tides.TidesToolbox
Doodson number decomposition as a sextuplet of integers.
negate(double[]) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Invert a vector.
negate() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
unary '-' operator.
negate() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Negate polynomial
negate() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Negate the instance.
negate() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Negate polynomial
negate() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get opposite of current polynomial
negate() - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (-this).
negate() - Method in class org.apache.commons.math3.dfp.Dfp
Returns a number that is this number with the sign bit reversed.
negate() - Method in interface org.apache.commons.math3.FieldElement
Returns the additive inverse of this element.
negate() - Method in class org.apache.commons.math3.fraction.BigFraction
Return the additive inverse of this fraction, returning the result in reduced form.
negate() - Method in class org.apache.commons.math3.fraction.Fraction
Return the additive inverse of this fraction.
negate() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get the opposite of the instance.
negate() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the opposite of the instance.
negate() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the opposite of the instance.
negate() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the opposite of the instance.
negate() - Method in interface org.apache.commons.math3.geometry.Vector
Get the opposite of the instance.
negate() - Method in class org.apache.commons.math3.util.BigReal
Returns the additive inverse of this element.
negate() - Method in class org.apache.commons.math3.util.Decimal64
Returns the additive inverse of this element.
negate() - Method in class org.orekit.utils.PVCoordinates
Get the opposite of the instance.
NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
A vector with all coordinates set to negative infinity.
NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
A vector with all coordinates set to negative infinity.
NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
A vector with all coordinates set to negative infinity.
NEGATIVE_INFINITY - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of Double.NEGATIVE_INFINITY as a Decimal64.
negativeOrNull() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is less than or equal to 0.
NelderMeadSimplex - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This class implements the Nelder-Mead simplex algorithm.
NelderMeadSimplex(int) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(int, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(int, double, double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(int, double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(double[], double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(double[][]) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(double[][], double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
NelderMeadSimplex(int) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated. Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(int, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated. Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(int, double, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated. Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(int, double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated. Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(double[]) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated. Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(double[], double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated. Build a Nelder-Mead simplex with specified coefficients.
NelderMeadSimplex(double[][]) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated. Build a Nelder-Mead simplex with default coefficients.
NelderMeadSimplex(double[][], double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.NelderMeadSimplex
Deprecated. Build a Nelder-Mead simplex with specified coefficients.
NEPTUNE - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Neptune.
NetworkCrawler - Class in org.orekit.data
Provider for data files directly fetched from network.
NetworkCrawler(URL...) - Constructor for class org.orekit.data.NetworkCrawler
Build a data classpath crawler.
NevilleInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Implements the Neville's Algorithm for interpolation of real univariate functions.
NevilleInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.NevilleInterpolator
 
newByCopy(SymmetricMatrix.SYMMETRIC, int, int, SymmetricMatrix.SYMMETRIC, RealMatrix) - Static method in class org.apache.commons.math3.linear.SymmetricMatrix
Create a symmetric matrix by copy of a triangle of a matrix.
newByCopyAndSymmetrize(SymmetricMatrix.SYMMETRIC, int, int, RealMatrix) - Static method in class org.apache.commons.math3.linear.SymmetricMatrix
Create a symmetric matrix by computation of the mean of the 2 triangles of a matrix.
newByCopyOfPackedStorage(SymmetricMatrix.SYMMETRIC, int, int, double[]) - Static method in class org.apache.commons.math3.linear.SymmetricMatrix
Creates a symmetric matrix using one of the triangles stored in 'packed' storage.
newCovarianceData(double[][]) - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
Add the covariance data.
newDfp() - Method in class org.apache.commons.math3.dfp.DfpField
Makes a Dfp with a value of 0.
newDfp(byte) - Method in class org.apache.commons.math3.dfp.DfpField
Create an instance from a byte value.
newDfp(int) - Method in class org.apache.commons.math3.dfp.DfpField
Create an instance from an int value.
newDfp(long) - Method in class org.apache.commons.math3.dfp.DfpField
Create an instance from a long value.
newDfp(double) - Method in class org.apache.commons.math3.dfp.DfpField
Create an instance from a double value.
newDfp(Dfp) - Method in class org.apache.commons.math3.dfp.DfpField
Copy constructor.
newDfp(String) - Method in class org.apache.commons.math3.dfp.DfpField
Create a Dfp given a String representation.
newDfp(byte, byte) - Method in class org.apache.commons.math3.dfp.DfpField
Creates a Dfp with a non-finite value.
newFixedLengthChromosome(List<T>) - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
Creates a new instance of the same class as this is, with a given arrayRepresentation.
newInstance() - Method in interface fr.cnes.sirius.validate.parallel.ParallelTaskFactory
Factory method providing new instances of T.
newInstance() - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance with a value of 0.
newInstance(byte) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from a byte value.
newInstance(int) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from an int value.
newInstance(long) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from a long value.
newInstance(double) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from a double value.
newInstance(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance by copying an existing one.
newInstance(String) - Method in class org.apache.commons.math3.dfp.Dfp
Create an instance from a String representation.
newInstance(byte, byte) - Method in class org.apache.commons.math3.dfp.Dfp
Creates an instance with a non-finite value.
newInstance() - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance with a value of 0.
newInstance(byte) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from a byte value.
newInstance(int) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from an int value.
newInstance(long) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from a long value.
newInstance(double) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from a double value.
newInstance(Dfp) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance by copying an existing one.
newInstance(String) - Method in class org.apache.commons.math3.dfp.DfpDec
Create an instance from a String representation.
newInstance(byte, byte) - Method in class org.apache.commons.math3.dfp.DfpDec
Creates an instance with a non-finite value.
newSampleData(double[], int, int) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Loads model x and y sample data from a flat input array, overriding any previous sample.
newSampleData(double[], double[][], double[][]) - Method in class org.apache.commons.math3.stat.regression.GLSMultipleLinearRegression
Replace sample data, overriding any previous sample.
newSampleData(double[], double[][]) - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Loads model x and y sample data, overriding any previous sample.
newSampleData(double[], int, int) - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Loads model x and y sample data from a flat input array, overriding any previous sample.
NewtonianAttraction - Class in org.orekit.forces.gravity
Force model for Newtonian central body attraction.
NewtonianAttraction(double) - Constructor for class org.orekit.forces.gravity.NewtonianAttraction
Simple constructor.
NewtonianAttraction(double, boolean) - Constructor for class org.orekit.forces.gravity.NewtonianAttraction
Simple constructor.
NewtonianAttraction(Parameter) - Constructor for class org.orekit.forces.gravity.NewtonianAttraction
Simple constructor using Parameter.
NewtonianAttraction(Parameter, boolean) - Constructor for class org.orekit.forces.gravity.NewtonianAttraction
Simple constructor using Parameter.
NewtonRaphsonSolver - Class in org.apache.commons.math3.analysis.solvers
Implements Newton's Method for finding zeros of real univariate differentiable functions.
NewtonRaphsonSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonRaphsonSolver
Construct a solver.
NewtonRaphsonSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonRaphsonSolver
Construct a solver.
NewtonSolver - Class in org.apache.commons.math3.analysis.solvers
Deprecated. as of 3.1, replaced by NewtonRaphsonSolver
NewtonSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonSolver
Deprecated. Construct a solver.
NewtonSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.NewtonSolver
Deprecated. Construct a solver.
newXSampleData(double[][]) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Loads new x sample data, overriding any previous data.
newXSampleData(double[][]) - Method in class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
Loads new x sample data, overriding any previous data.
newYSampleData(double[]) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Loads new y sample data, overriding any previous data.
next() - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapSparseIterator
Deprecated. 
next() - Method in class org.apache.commons.math3.linear.RealVector.SparseEntryIterator
Deprecated. 
next(int) - Method in class org.apache.commons.math3.random.AbstractWell
Generate next pseudorandom number.
next(int) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Generate next pseudorandom number.
next(int) - Method in class org.apache.commons.math3.random.ISAACRandom
Generate next pseudorandom number.
next(int) - Method in class org.apache.commons.math3.random.MersenneTwister
Generate next pseudorandom number.
next(int) - Method in class org.apache.commons.math3.random.Well1024a
Generate next pseudorandom number.
next(int) - Method in class org.apache.commons.math3.random.Well19937a
Generate next pseudorandom number.
next(int) - Method in class org.apache.commons.math3.random.Well19937c
Generate next pseudorandom number.
next(int) - Method in class org.apache.commons.math3.random.Well44497a
Generate next pseudorandom number.
next(int) - Method in class org.apache.commons.math3.random.Well44497b
Generate next pseudorandom number.
next(int) - Method in class org.apache.commons.math3.random.Well512a
Generate next pseudorandom number.
next() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
 
nextAfter(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Returns the next number greater than this one in the direction of x.
nextAfter(Dfp) - Method in class org.apache.commons.math3.dfp.DfpDec
Returns the next number greater than this one in the direction of x.
nextAfter(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Get the next machine representable number after a number, moving in the direction of another number.
nextAfter(float, double) - Static method in class org.apache.commons.math3.util.FastMath
Get the next machine representable number after a number, moving in the direction of another number.
nextBeta(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Beta Distribution.
nextBeta(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Beta Distribution.
nextBinomial(int, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Binomial Distribution.
nextBinomial(int, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Binomial Distribution.
nextBoolean() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBytes(byte[]) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in class org.apache.commons.math3.random.RandomAdaptor
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in interface org.apache.commons.math3.random.RandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextCauchy(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Cauchy Distribution.
nextCauchy(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Cauchy Distribution.
nextChiSquare(double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the ChiSquare Distribution.
nextChiSquare(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the ChiSquare Distribution.
nextDouble() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextExponential(double) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a random value from the exponential distribution with specified mean.
nextExponential(double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the exponential distribution with specified mean.
nextExponential(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the exponential distribution with specified mean.
nextF(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the F Distribution.
nextF(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the F Distribution.
nextFloat() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextGamma(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Gamma Distribution.
nextGamma(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Gamma Distribution.
nextGaussian() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian(double, double) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a random value from the Normal (or Gaussian) distribution with specified mean and standard deviation.
nextGaussian(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Normal (or Gaussian) distribution with specified mean and standard deviation.
nextGaussian(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Normal (or Gaussian) distribution with specified mean and standard deviation.
nextGaussian() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGeneration() - Method in class org.apache.commons.math3.genetics.ElitisticListPopulation
Start the population for the next generation.
nextGeneration(Population) - Method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Evolve the given population into the next generation.
nextGeneration() - Method in interface org.apache.commons.math3.genetics.Population
Start the population for the next generation.
nextHexString(int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a random string of hex characters of length len.
nextHexString(int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random string of hex characters of length len.
nextHexString(int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random string of hex characters of length len.
nextHypergeometric(int, int, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Hypergeometric Distribution.
nextHypergeometric(int, int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Hypergeometric Distribution.
nextInt() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt(int, int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a uniformly distributed random integer between lower and upper (endpoints included).
nextInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random integer between lower and upper (endpoints included).
nextInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a uniformly distributed random integer between lower and upper (endpoints included).
nextInt() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInversionDeviate(RealDistribution) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. use the distribution's sample() method
nextInversionDeviate(IntegerDistribution) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. use the distribution's sample() method
nextLong() - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math3.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong(long, long) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a uniformly distributed random long integer between lower and upper (endpoints included).
nextLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random long integer between lower and upper (endpoints included).
nextLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a uniformly distributed random long integer between lower and upper (endpoints included).
nextLong() - Method in interface org.apache.commons.math3.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextNormalizedDouble() - Method in class org.apache.commons.math3.random.GaussianRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextNormalizedDouble() - Method in interface org.apache.commons.math3.random.NormalizedRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextNormalizedDouble() - Method in class org.apache.commons.math3.random.StableRandomGenerator
Generate a random scalar with zero location and unit scale.
nextNormalizedDouble() - Method in class org.apache.commons.math3.random.UniformRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextPascal(int, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Pascal Distribution.
nextPascal(int, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Pascal Distribution.
nextPermutation(int, int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates an integer array of length k whose entries are selected randomly, without repetition, from the integers 0, ..., n - 1 (inclusive).
nextPermutation(int, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates an integer array of length k whose entries are selected randomly, without repetition, from the integers 0, ..., n - 1 (inclusive).
nextPermutation(int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates an integer array of length k whose entries are selected randomly, without repetition, from the integers 0, ..., n - 1 (inclusive).
nextPoisson(double) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a random value from the Poisson distribution with the given mean.
nextPoisson(double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Poisson distribution with the given mean.
nextPoisson(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Poisson distribution with the given mean.
nextSample(Collection<?>, int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Returns an array of k objects selected randomly from the Collection c.
nextSample(Collection<?>, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Returns an array of k objects selected randomly from the Collection c.
nextSample(Collection<?>, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Returns an array of k objects selected randomly from the Collection c.
nextSecureHexString(int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a random string of hex characters from a secure random sequence.
nextSecureHexString(int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random string of hex characters from a secure random sequence.
nextSecureHexString(int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random string of hex characters from a secure random sequence.
nextSecureInt(int, int) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a uniformly distributed random integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureInt(int, int) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a uniformly distributed random integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureLong(long, long) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a uniformly distributed random long integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random long integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureLong(long, long) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a uniformly distributed random long integer between lower and upper (endpoints included) from a secure random sequence.
nextT(double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the T Distribution.
nextT(double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the T Distribution.
nextUniform(double, double) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a uniformly distributed random value from the open interval (lower, upper) (i.e., endpoints excluded).
nextUniform(double, double, boolean) - Method in interface org.apache.commons.math3.random.RandomData
Deprecated. Generates a uniformly distributed random value from the interval (lower, upper) or the interval [lower, upper).
nextUniform(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random value from the open interval (lower, upper) (i.e., endpoints excluded).
nextUniform(double, double, boolean) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a uniformly distributed random value from the interval (lower, upper) or the interval [lower, upper).
nextUniform(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a uniformly distributed random value from the open interval (lower, upper) (i.e., endpoints excluded).
nextUniform(double, double, boolean) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a uniformly distributed random value from the interval (lower, upper) or the interval [lower, upper).
nextUp(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute next number towards positive infinity.
nextUp(float) - Static method in class org.apache.commons.math3.util.FastMath
Compute next number towards positive infinity.
nextVector() - Method in class org.apache.commons.math3.random.CorrelatedRandomVectorGenerator
Generate a correlated random vector.
nextVector() - Method in interface org.apache.commons.math3.random.RandomVectorGenerator
Generate a random vector.
nextVector() - Method in class org.apache.commons.math3.random.UncorrelatedRandomVectorGenerator
Generate an uncorrelated random vector.
nextVector() - Method in class org.apache.commons.math3.random.UniformlyCorrelatedRandomVectorGenerator
Generate a correlated random vector.
nextVector() - Method in class org.apache.commons.math3.random.UnitSphereRandomVectorGenerator
Generate a random vector.
nextWeibull(double, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Weibull Distribution.
nextWeibull(double, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Weibull Distribution.
nextZipf(int, double) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Generates a random value from the Zipf Distribution.
nextZipf(int, double) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Generates a random value from the Zipf Distribution.
NO_LIBRATION - Static variable in class org.orekit.frames.configuration.libration.LibrationCorrectionModelFactory
Ignore the libration effects.
NO_PN - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
No precession Nutation.
NO_SP - Static variable in class org.orekit.frames.configuration.sp.SPrimeModelFactory
Ignore SP correction.
NO_TIDE - Static variable in class org.orekit.frames.configuration.tides.TidalCorrectionModelFactory
Ignore tidal effects.
NO_TRANSITIONS - Static variable in class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
The transition points are ignored.
NOAA_FILENAME - Static variable in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataFactory
Default file name for NOAA
NOAAFormatReader - Class in org.orekit.forces.atmospheres.solarActivity
This class reads ACSOL format solar activity data
NOAAFormatReader(String) - Constructor for class org.orekit.forces.atmospheres.solarActivity.NOAAFormatReader
Constructor.
NoBracketingException - Exception in org.apache.commons.math3.exception
Exception to be thrown when function values have the same sign at both ends of an interval.
NoBracketingException(double, double, double, double) - Constructor for exception org.apache.commons.math3.exception.NoBracketingException
Construct the exception.
NoBracketingException(Localizable, double, double, double, double, Object...) - Constructor for exception org.apache.commons.math3.exception.NoBracketingException
Construct the exception with a specific context.
NoDataException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the required data is missing.
NoDataException() - Constructor for exception org.apache.commons.math3.exception.NoDataException
Construct the exception.
NoDataException(Localizable) - Constructor for exception org.apache.commons.math3.exception.NoDataException
Construct the exception with a specific context.
NodeDetector - Class in org.orekit.propagation.events
Finder for node crossing events.
NodeDetector(Orbit, Frame, int) - Constructor for class org.orekit.propagation.events.NodeDetector
Build a new instance.
NodeDetector(Orbit, Frame, int, double) - Constructor for class org.orekit.propagation.events.NodeDetector
Build a new instance.
NodeDetector(Frame, int, double, double) - Constructor for class org.orekit.propagation.events.NodeDetector
Build a new instance.
NodeDetector(Frame, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class org.orekit.propagation.events.NodeDetector
Build a new instance for both ascending and descending node detection.
NodeDetector(Frame, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class org.orekit.propagation.events.NodeDetector
Build a new instance for both ascending and descending node detection.
NodeDetector(Frame, int, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.NodeDetector
Build a new instance.
NodeDetector(Frame, int, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.NodeDetector
Build a new instance.
NoEOP1980HistoryLoader - Class in org.orekit.frames.configuration.eop
NoEOP2000History.
NoEOP1980HistoryLoader() - Constructor for class org.orekit.frames.configuration.eop.NoEOP1980HistoryLoader
Constructor.
NoEOP2000History - Class in org.orekit.frames.configuration.eop
NoEOP2000History.
NoEOP2000History() - Constructor for class org.orekit.frames.configuration.eop.NoEOP2000History
NoEOP2000History.
NoFeasibleSolutionException - Exception in org.apache.commons.math3.optim.linear
This class represents exceptions thrown by optimizers when no solution fulfills the constraints.
NoFeasibleSolutionException() - Constructor for exception org.apache.commons.math3.optim.linear.NoFeasibleSolutionException
Simple constructor using a default message.
NoFeasibleSolutionException - Exception in org.apache.commons.math3.optimization.linear
Deprecated. As of 3.1 (to be removed in 4.0).
NoFeasibleSolutionException() - Constructor for exception org.apache.commons.math3.optimization.linear.NoFeasibleSolutionException
Deprecated. Simple constructor using a default message.
noInhibition(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Checks if at least an inhibition target is at least partially in its associated inhibition field at a date
NoLibrationCorrection - Class in org.orekit.frames.configuration.libration
This class ignores the libration effects.
NoLibrationCorrection() - Constructor for class org.orekit.frames.configuration.libration.NoLibrationCorrection
Simple constructor.
NonInertialContribution - Class in fr.cnes.sirius.patrius.stela.forces.noninertial
Class representing the non-inertial contribution for STELA propagator.
NonInertialContribution(int, Frame) - Constructor for class fr.cnes.sirius.patrius.stela.forces.noninertial.NonInertialContribution
Constructor.
NonLinearConjugateGradientOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar.gradient
Non-linear conjugate gradient optimizer.
NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
Constructor with default line search solver and preconditioner.
NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>, UnivariateSolver) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
Constructor with default preconditioner.
NonLinearConjugateGradientOptimizer(NonLinearConjugateGradientOptimizer.Formula, ConvergenceChecker<PointValuePair>, UnivariateSolver, Preconditioner) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
 
NonLinearConjugateGradientOptimizer - Class in org.apache.commons.math3.optimization.general
Deprecated. As of 3.1 (to be removed in 4.0).
NonLinearConjugateGradientOptimizer(ConjugateGradientFormula) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated. See SimpleValueChecker.SimpleValueChecker()
NonLinearConjugateGradientOptimizer(ConjugateGradientFormula, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated. Constructor with default line search solver and preconditioner.
NonLinearConjugateGradientOptimizer(ConjugateGradientFormula, ConvergenceChecker<PointValuePair>, UnivariateSolver) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated. Constructor with default preconditioner.
NonLinearConjugateGradientOptimizer(ConjugateGradientFormula, ConvergenceChecker<PointValuePair>, UnivariateSolver, Preconditioner) - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated.  
NonLinearConjugateGradientOptimizer.BracketingStep - Class in org.apache.commons.math3.optim.nonlinear.scalar.gradient
The initial step is a factor with respect to the search direction (which itself is roughly related to the gradient of the function).
NonLinearConjugateGradientOptimizer.BracketingStep(double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.BracketingStep
 
NonLinearConjugateGradientOptimizer.Formula - Enum in org.apache.commons.math3.optim.nonlinear.scalar.gradient
Available choices of update formulas for the updating the parameter that is used to compute the successive conjugate search directions.
NonLinearConjugateGradientOptimizer.IdentityPreconditioner - Class in org.apache.commons.math3.optim.nonlinear.scalar.gradient
Default identity preconditioner.
NonLinearConjugateGradientOptimizer.IdentityPreconditioner() - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
 
NonLinearConjugateGradientOptimizer.IdentityPreconditioner - Class in org.apache.commons.math3.optimization.general
Deprecated. Default identity preconditioner.
NonLinearConjugateGradientOptimizer.IdentityPreconditioner() - Constructor for class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
Deprecated.  
NonMonotonicSequenceException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the a sequence of values is not monotonically increasing or decreasing.
NonMonotonicSequenceException(Number, Number, int) - Constructor for exception org.apache.commons.math3.exception.NonMonotonicSequenceException
Construct the exception.
NonMonotonicSequenceException(Number, Number, int, MathArrays.OrderDirection, boolean) - Constructor for exception org.apache.commons.math3.exception.NonMonotonicSequenceException
Construct the exception.
NonNegativeConstraint - Class in org.apache.commons.math3.optim.linear
A constraint for a linear optimization problem indicating whether all variables must be restricted to non-negative values.
NonNegativeConstraint(boolean) - Constructor for class org.apache.commons.math3.optim.linear.NonNegativeConstraint
 
NonPositiveDefiniteMatrixException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a positive definite matrix is expected.
NonPositiveDefiniteMatrixException(double, int, double) - Constructor for exception org.apache.commons.math3.linear.NonPositiveDefiniteMatrixException
Construct an exception.
NonPositiveDefiniteOperatorException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a symmetric, definite positive RealLinearOperator is expected.
NonPositiveDefiniteOperatorException() - Constructor for exception org.apache.commons.math3.linear.NonPositiveDefiniteOperatorException
Creates a new instance of this class.
NonSelfAdjointOperatorException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a self-adjoint RealLinearOperator is expected.
NonSelfAdjointOperatorException() - Constructor for exception org.apache.commons.math3.linear.NonSelfAdjointOperatorException
Creates a new instance of this class.
NonSquareMatrixException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a square matrix is expected.
NonSquareMatrixException(int, int) - Constructor for exception org.apache.commons.math3.linear.NonSquareMatrixException
Construct an exception from the mismatched dimensions.
NonSquareOperatorException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a square linear operator is expected.
NonSquareOperatorException(int, int) - Constructor for exception org.apache.commons.math3.linear.NonSquareOperatorException
Construct an exception from the mismatched dimensions.
NonSymmetricMatrixException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a symmetric matrix is expected.
NonSymmetricMatrixException(int, int, double) - Constructor for exception org.apache.commons.math3.linear.NonSymmetricMatrixException
Construct an exception.
NoPrecessionNutation - Class in org.orekit.frames.configuration.precessionnutation
In this model the CIP doesnt move.
NoPrecessionNutation() - Constructor for class org.orekit.frames.configuration.precessionnutation.NoPrecessionNutation
 
nordsieck - Variable in class org.apache.commons.math3.ode.MultistepIntegrator
Nordsieck matrix of the higher scaled derivatives.
NordsieckStepInterpolator - Class in org.apache.commons.math3.ode.sampling
This class implements an interpolator for integrators using Nordsieck representation.
NordsieckStepInterpolator() - Constructor for class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Simple constructor.
NordsieckStepInterpolator(NordsieckStepInterpolator) - Constructor for class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Copy constructor.
normalApproximateProbability(int) - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Calculates the Poisson distribution function using a normal approximation.
NormalDistribution - Class in org.apache.commons.math3.distribution
Implementation of the normal (gaussian) distribution.
NormalDistribution() - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
Create a normal distribution with mean equal to zero and standard deviation equal to one.
NormalDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
Create a normal distribution using the given mean and standard deviation.
NormalDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
Create a normal distribution using the given mean, standard deviation and inverse cumulative distribution accuracy.
NormalDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.NormalDistribution
Creates a normal distribution.
normalize() - Method in class org.apache.commons.math3.complex.Quaternion
Computes the normalized quaternion (the versor of the instance).
normalize() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get a normalized vector aligned with the instance.
normalize() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a normalized vector aligned with the instance.
normalize() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a normalized vector aligned with the instance.
normalize() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get a normalized vector aligned with the instance.
normalize() - Method in interface org.apache.commons.math3.geometry.Vector
Get a normalized vector aligned with the instance.
normalize(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Normalize (standardize) the sample, so it is has a mean of 0 and a standard deviation of 1.
normalize(double[][]) - Static method in class org.orekit.forces.gravity.GravityToolbox
Normalize an array of coefficients.
normalize() - Method in class org.orekit.utils.PVCoordinates
Normalize the position part of the instance.
normalizeAngle(double, double) - Static method in class org.apache.commons.math3.util.MathUtils
Normalize an angle in a 2&pi wide interval around a center value.
normalizeArray(double[], double) - Static method in class org.apache.commons.math3.util.MathArrays
Normalizes an array to make it sum to a specified value.
normalizedC - Variable in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
fully normalized tesseral-sectorial coefficients matrix.
normalizedJ - Variable in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
fully normalized zonal coefficients array.
NormalizedRandomGenerator - Interface in org.apache.commons.math3.random
This interface represent a normalized random generator for scalars.
normalizedS - Variable in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
fully normalized tesseral-sectorial coefficients matrix.
normalizeTransformedData(double[][], DftNormalization, TransformType) - Static method in class org.apache.commons.math3.transform.AbstractFastFourierTransformer
Applies the proper normalization to the specified transformed data.
NoSpCorrection - Class in org.orekit.frames.configuration.sp
This class ignores the quantity s'.
NoSpCorrection() - Constructor for class org.orekit.frames.configuration.sp.NoSpCorrection
Simple constructor.
NotANumberException - Exception in org.apache.commons.math3.exception
Exception to be thrown when a number is not a number.
NotANumberException() - Constructor for exception org.apache.commons.math3.exception.NotANumberException
Construct the exception.
NotARotationMatrixException - Exception in org.apache.commons.math3.geometry.euclidean.threed
This class represents exceptions thrown while building rotations from matrices.
NotARotationMatrixException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.geometry.euclidean.threed.NotARotationMatrixException
Simple constructor.
NotFiniteNumberException - Exception in org.apache.commons.math3.exception
Exception to be thrown when a number is not finite.
NotFiniteNumberException(Number, Object...) - Constructor for exception org.apache.commons.math3.exception.NotFiniteNumberException
Construct the exception.
NotFiniteNumberException(Localizable, Number, Object...) - Constructor for exception org.apache.commons.math3.exception.NotFiniteNumberException
Construct the exception with a specific context.
NoTidalCorrection - Class in org.orekit.frames.configuration.tides
This class ignores the tidal effects.
NoTidalCorrection() - Constructor for class org.orekit.frames.configuration.tides.NoTidalCorrection
Simple constructor.
NotPositiveException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the argument is negative.
NotPositiveException(Number) - Constructor for exception org.apache.commons.math3.exception.NotPositiveException
Construct the exception.
NotPositiveException(Localizable, Number) - Constructor for exception org.apache.commons.math3.exception.NotPositiveException
Construct the exception with a specific context.
NotStrictlyPositiveException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the argument is negative.
NotStrictlyPositiveException(Number) - Constructor for exception org.apache.commons.math3.exception.NotStrictlyPositiveException
Construct the exception.
NotStrictlyPositiveException(Localizable, Number) - Constructor for exception org.apache.commons.math3.exception.NotStrictlyPositiveException
Construct the exception with a specific context.
NPointCrossover<T> - Class in org.apache.commons.math3.genetics
N-point crossover policy.
NPointCrossover(int) - Constructor for class org.apache.commons.math3.genetics.NPointCrossover
Creates a new NPointCrossover policy using the given number of points.
NRLMSISE00 - Class in org.orekit.forces.atmospheres.MSIS2000
NRLMSISE-00 atmospheric model.
NRLMSISE00() - Constructor for class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
Constructor.
NRLMSISE00Data - Class in org.orekit.forces.atmospheres.MSIS2000
NRLMSIS00 data class
nthDerivative(int) - Method in class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
 
nthDerivative(int) - Method in class org.orekit.attitudes.kinematics.AbstractVector3DFunction
Compute the Vector3DFunction representing the n-th derivative of the current vector function.
The differentiation is performed using a numerical differentiation method.
nthDerivative(int) - Method in interface org.orekit.attitudes.kinematics.Vector3DFunction
Compute the Vector3DFunction representing the n-th derivative of the current vector function.
NthOccurrenceDetector - Class in org.orekit.propagation.events
This event detector detects the nth occurrence of an underlying event detector.
NthOccurrenceDetector(EventDetector, int, EventDetector.Action) - Constructor for class org.orekit.propagation.events.NthOccurrenceDetector
Constructor.
NthOccurrenceDetector(EventDetector, int, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.NthOccurrenceDetector
Constructor.
nthRoot(int) - Method in class org.apache.commons.math3.complex.Complex
Computes the n-th roots of this complex number.
NULL_CORRECTION - Static variable in class org.orekit.frames.configuration.eop.NutationCorrection
Null correction (ddeps = 0, ddpsi = 0).
NULL_CORRECTION - Static variable in class org.orekit.frames.configuration.eop.PoleCorrection
Null correction (xp = 0, yp = 0).
NullArgumentException - Exception in org.apache.commons.math3.exception
All conditions checks that fail due to a null argument must throw this exception.
NullArgumentException() - Constructor for exception org.apache.commons.math3.exception.NullArgumentException
Default constructor.
NullArgumentException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.NullArgumentException
 
NullMassDetector - Class in org.orekit.propagation.events
This class creates an event detector that detects when the global mass of the satellite becomes null.
NullMassDetector(double, double, MassProvider) - Constructor for class org.orekit.propagation.events.NullMassDetector
Inherited constructor.
NullMassDetector(int, double, double, MassProvider) - Constructor for class org.orekit.propagation.events.NullMassDetector
Inherited constructor.
NullMassDetector(MassProvider) - Constructor for class org.orekit.propagation.events.NullMassDetector
Build a new instance (based on DateDetector).
NullMassPartDetector - Class in org.orekit.propagation.events
This class creates an event detector that detects when the mass of the element becomes null.
NullMassPartDetector(double, double, MassProvider, String) - Constructor for class org.orekit.propagation.events.NullMassPartDetector
Inherited constructor.
NullMassPartDetector(int, double, double, MassProvider, String) - Constructor for class org.orekit.propagation.events.NullMassPartDetector
Inherited constructor.
NullMassPartDetector(MassProvider, String) - Constructor for class org.orekit.propagation.events.NullMassPartDetector
Build a new instance MaxCheck is set to 10.e9, so almost no other date can be added.
NumberIsTooLargeException - Exception in org.apache.commons.math3.exception
Exception to be thrown when a number is too large.
NumberIsTooLargeException(Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooLargeException
Construct the exception.
NumberIsTooLargeException(Localizable, Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooLargeException
Construct the exception with a specific context.
NumberIsTooSmallException - Exception in org.apache.commons.math3.exception
Exception to be thrown when a number is too small.
NumberIsTooSmallException(Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooSmallException
Construct the exception.
NumberIsTooSmallException(Localizable, Number, Number, boolean) - Constructor for exception org.apache.commons.math3.exception.NumberIsTooSmallException
Construct the exception with a specific context.
NumberTransformer - Interface in org.apache.commons.math3.util
Subclasses implementing this interface can transform Objects to doubles.
NumericalPropagator - Class in org.orekit.propagation.numerical
This class propagates SpacecraftState using numerical integration.
NumericalPropagator(FirstOrderIntegrator) - Constructor for class org.orekit.propagation.numerical.NumericalPropagator
Create a new instance of NumericalPropagator, based on orbit definition mu.
NutationCorrection - Class in org.orekit.frames.configuration.eop
Simple container class for nutation correction (IAU 1980) parameters.
NutationCorrection(double, double) - Constructor for class org.orekit.frames.configuration.eop.NutationCorrection
Simple constructor.
nxmax - Variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Maximal indices in the first dimension of fthe tab in dimension 1, 2 and 3.
nymax - Variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Maximal indices in the second dimension of ftab in dimension 2 and 3.
nzmax - Variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Maximal indices in the third dimension of ftab in dimension 3.

O

objective - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1.
ObjectiveFunction - Class in org.apache.commons.math3.optim.nonlinear.scalar
Scalar function to be optimized.
ObjectiveFunction(MultivariateFunction) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.ObjectiveFunction
 
ObjectiveFunctionGradient - Class in org.apache.commons.math3.optim.nonlinear.scalar
Gradient of the scalar function to be optimized.
ObjectiveFunctionGradient(MultivariateVectorFunction) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.ObjectiveFunctionGradient
 
OccurrenceFilter - Class in fr.cnes.sirius.patrius.events.postprocessing
 
OccurrenceFilter(String, int, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.OccurrenceFilter
Constructor
OceanTides - Class in org.orekit.forces.gravity.tides
This class implements the perturbating force due to ocean tides.
OceanTides(Frame, double, double, double, int, int, boolean, IOceanTidesDataProvider) - Constructor for class org.orekit.forces.gravity.tides.OceanTides
Constructor.
OceanTides(Frame, double, double, double, int, int, int, int, boolean, IOceanTidesDataProvider) - Constructor for class org.orekit.forces.gravity.tides.OceanTides
Constructor.
OceanTides(Frame, Parameter, Parameter, Parameter, int, int, boolean, IOceanTidesDataProvider) - Constructor for class org.orekit.forces.gravity.tides.OceanTides
Constructor using Parameter.
OceanTides(Frame, Parameter, Parameter, Parameter, int, int, int, int, boolean, IOceanTidesDataProvider) - Constructor for class org.orekit.forces.gravity.tides.OceanTides
Constructor using Parameter.
OceanTidesCoefficientsFactory - Class in org.orekit.forces.gravity.tides.coefficients
Factory used to read ocean tides coefficients files in different formats and return an OceanTidesCoefficientsProvider
OceanTidesCoefficientsProvider - Interface in org.orekit.forces.gravity.tides.coefficients
Interface for ocean tides coefficients provider.
OceanTidesCoefficientsReader - Class in org.orekit.forces.gravity.tides.coefficients
This abstract class represents a Ocean Tides Coefficients file reader.
OceanTidesCoefficientsReader(String) - Constructor for class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Simple constructor.
OceanTidesCoefficientsSet - Class in org.orekit.forces.gravity.tides.coefficients
Represents a line from the ocean tides data file.
OceanTidesCoefficientsSet(double, int, int, double, double, double, double, double, double, double, double) - Constructor for class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsSet
Constructor.
OceanTidesDataProvider - Class in org.orekit.forces.gravity.tides
Ocean tides parameters given by the IERS 1996, 2003 or GINS 2004 standard.
OceanTidesDataProvider(OceanTidesCoefficientsProvider, TidesStandards.TidesStandard) - Constructor for class org.orekit.forces.gravity.tides.OceanTidesDataProvider
Simple constructor.
OCTAVE_FORMAT - Static variable in class org.apache.commons.math3.linear.MatrixUtils
A format for RealMatrix objects compatible with octave.
ODEIntegrator - Interface in org.apache.commons.math3.ode
This interface defines the common parts shared by integrators for first and second order differential equations.
offsetFrom(AbsoluteDate, TimeScale) - Method in class org.orekit.time.AbsoluteDate
Compute the apparent clock offset between two instant in the perspective of a specific time scale.
offsetFrom(DateTimeComponents) - Method in class org.orekit.time.DateTimeComponents
Compute the seconds offset between two instances.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.GalileoScale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.GMSTScale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.GPSScale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.TAIScale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.TCBScale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.TCGScale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.TDBScale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in interface org.orekit.time.TimeScale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.TTScale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.UT1Scale
Get the offset to convert locations from TAIScale to instance.
offsetFromTAI(AbsoluteDate) - Method in class org.orekit.time.UTCScale
Get the offset to convert locations from TAIScale to instance.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.GalileoScale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.GMSTScale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.GPSScale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.TAIScale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.TCBScale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.TCGScale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.TDBScale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in interface org.orekit.time.TimeScale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.TTScale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.UT1Scale
Get the offset to convert locations from instance to TAIScale.
offsetToTAI(DateComponents, TimeComponents) - Method in class org.orekit.time.UTCScale
Get the offset to convert locations from instance to TAIScale.
oldStepHandler - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Entry Step handler.
OLSMultipleLinearRegression - Class in org.apache.commons.math3.stat.regression
Implements ordinary least squares (OLS) to estimate the parameters of a multiple linear regression model.
OLSMultipleLinearRegression() - Constructor for class org.apache.commons.math3.stat.regression.OLSMultipleLinearRegression
 
omega - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
final perigee argument.
omgdot - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
common parameter for perigee argument (omega) computation.
OmnidirectionalField - Class in fr.cnes.sirius.patrius.fieldsofview
This class describes an omnidirectional field of view : any vector is in it, the angular distance is always 1 (positive).
OmnidirectionalField(String) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.OmnidirectionalField
Constructor of an omnidirectional field of view.
ONE - Static variable in class org.apache.commons.math3.complex.Complex
A complex number representing "1.0 + 0.0i"
ONE - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1".
ONE - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1".
ONE - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Unit (coordinates: 1).
ONE - Static variable in class org.apache.commons.math3.util.BigReal
A big real representing 1.
ONE - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of 1d as a Decimal64.
ONE_FIFTH - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1/5".
ONE_FIFTH - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1/5".
ONE_HALF - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1/2".
ONE_HALF - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1/2".
ONE_POINT_FIVE - Static variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Constant 1.5
ONE_QUARTER - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1/4".
ONE_QUARTER - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1/4".
ONE_THIRD - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "1/3".
ONE_THIRD - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "1/3".
OneAxisEllipsoid - Class in org.orekit.bodies
Modeling of a one-axis ellipsoid.
OneAxisEllipsoid(double, double, Frame) - Constructor for class org.orekit.bodies.OneAxisEllipsoid
Simple constructor.
OnePointCrossover<T> - Class in org.apache.commons.math3.genetics
One point crossover policy.
OnePointCrossover() - Constructor for class org.apache.commons.math3.genetics.OnePointCrossover
 
OneSatEventDetectorWrapper - Class in fr.cnes.sirius.patrius.propagation.events.multi
This class allows to convert an EventDetector into a MultiEventDetector.
OneSatEventDetectorWrapper(EventDetector, String) - Constructor for class fr.cnes.sirius.patrius.propagation.events.multi.OneSatEventDetectorWrapper
Simple constructor.
OneWayAnova - Class in org.apache.commons.math3.stat.inference
Implements one-way ANOVA (analysis of variance) statistics.
OneWayAnova() - Constructor for class org.apache.commons.math3.stat.inference.OneWayAnova
Default constructor.
oneWayAnovaFValue(Collection<double[]>) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
oneWayAnovaPValue(Collection<double[]>) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
oneWayAnovaTest(Collection<double[]>, double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
OpenIntToDoubleHashMap - Class in org.apache.commons.math3.util
Open addressed map from int to double.
OpenIntToDoubleHashMap() - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Build an empty map with default size and using NaN for missing entries.
OpenIntToDoubleHashMap(double) - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Build an empty map with default size
OpenIntToDoubleHashMap(int) - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Build an empty map with specified size and using NaN for missing entries.
OpenIntToDoubleHashMap(int, double) - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Build an empty map with specified size.
OpenIntToDoubleHashMap(OpenIntToDoubleHashMap) - Constructor for class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Copy constructor.
OpenIntToDoubleHashMap.Iterator - Class in org.apache.commons.math3.util
Iterator class for the map.
OpenIntToFieldHashMap<T extends FieldElement<T>> - Class in org.apache.commons.math3.util
Open addressed map from int to FieldElement.
OpenIntToFieldHashMap(Field<T>) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Build an empty map with default size and using zero for missing entries.
OpenIntToFieldHashMap(Field<T>, T) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Build an empty map with default size
OpenIntToFieldHashMap(Field<T>, int) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Build an empty map with specified size and using zero for missing entries.
OpenIntToFieldHashMap(Field<T>, int, T) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Build an empty map with specified size.
OpenIntToFieldHashMap(OpenIntToFieldHashMap<T>) - Constructor for class org.apache.commons.math3.util.OpenIntToFieldHashMap
Copy constructor.
OpenIntToFieldHashMap.Iterator - Class in org.apache.commons.math3.util
Iterator class for the map.
OpenMapRealMatrix - Class in org.apache.commons.math3.linear
Deprecated. As of version 3.1, this class is deprecated, for reasons exposed in this JIRA ticket. This class will be removed in version 4.0.
OpenMapRealMatrix(int, int) - Constructor for class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Build a sparse matrix with the supplied row and column dimensions.
OpenMapRealMatrix(OpenMapRealMatrix) - Constructor for class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Build a matrix by copying another one.
OpenMapRealVector - Class in org.apache.commons.math3.linear
Deprecated. As of version 3.1, this class is deprecated, for reasons exposed in this JIRA ticket. This class will be removed in version 4.0.
OpenMapRealVector() - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Build a 0-length vector.
OpenMapRealVector(int) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Construct a vector of zeroes.
OpenMapRealVector(int, double) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Construct a vector of zeroes, specifying zero tolerance.
OpenMapRealVector(OpenMapRealVector, int) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Build a resized vector, for use with append.
OpenMapRealVector(int, int) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Build a vector with known the sparseness (for advanced use only).
OpenMapRealVector(int, int, double) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Build a vector with known the sparseness and zero tolerance setting (for advanced use only).
OpenMapRealVector(double[]) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Create from an array.
OpenMapRealVector(double[], double) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Create from an array, specifying zero tolerance.
OpenMapRealVector(Double[]) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Create from an array.
OpenMapRealVector(Double[], double) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Create from an array.
OpenMapRealVector(OpenMapRealVector) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Copy constructor.
OpenMapRealVector(RealVector) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Generic copy constructor.
OpenMapRealVector.OpenMapEntry - Class in org.apache.commons.math3.linear
Deprecated. Implementation of Entry optimized for OpenMap.
OpenMapRealVector.OpenMapEntry(OpenIntToDoubleHashMap.Iterator) - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapEntry
Deprecated. Build an entry from an iterator point to an element.
OpenMapRealVector.OpenMapSparseIterator - Class in org.apache.commons.math3.linear
Deprecated. Iterator class to do iteration over just the non-zero elements.
OpenMapRealVector.OpenMapSparseIterator() - Constructor for class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapSparseIterator
Deprecated. Simple constructor.
operate(T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the result of multiplying this by the vector v.
operate(FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of multiplying this by the vector v.
operate(RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of multiplying this by the vector x.
operate(T[]) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the result of multiplying this by the vector v.
operate(T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the result of multiplying this by the vector v.
operate(T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the result of multiplying this by the vector v.
operate(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the result of multiplying this by the vector v.
operate(RealVector) - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
Returns the result of multiplying this by the vector x.
operate(RealVector) - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns the result of multiplying this by the vector x.
operate(double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of multiplying this by the vector v.
operate(RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of multiplying this by the vector v.
operateTranspose(RealVector) - Method in class org.apache.commons.math3.linear.RealLinearOperator
Returns the result of multiplying the transpose of this operator by the vector x (optional operation).
OPERATOR - Static variable in class org.apache.commons.math3.linear.ConjugateGradient
Key for the exception context.
oppositeAngle(double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.utils.AngleTools
Computes the opposite of the input angle, and then tries to express it in the input interval.
oppositeRelationship() - Method in enum org.apache.commons.math3.optim.linear.Relationship
Gets the relationship obtained when multiplying all coefficients by -1.
oppositeRelationship() - Method in enum org.apache.commons.math3.optimization.linear.Relationship
Deprecated. Get the relationship obtained when multiplying all coefficients by -1.
OptimizationData - Interface in org.apache.commons.math3.optim
Marker interface.
OptimizationData - Interface in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.BaseMultivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.BaseOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.linear.LinearOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.GradientMultivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.CMAESOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.SimplexOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.vector.JacobianMultivariateVectorOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultivariateVectorOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.univariate.MultiStartUnivariateOptimizer
Stores data and performs the optimization.
optimize(OptimizationData...) - Method in class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
Stores data and performs the optimization.
optimize(int, FUNC, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.BaseMultivariateMultiStartOptimizer
Deprecated. Optimize an objective function.
optimize(int, FUNC, GoalType, double[]) - Method in interface org.apache.commons.math3.optimization.BaseMultivariateOptimizer
Deprecated. As of 3.1. In 4.0, it will be replaced by the declaration corresponding to this method.
optimize(int, FUNC, GoalType, double[], double[], double[]) - Method in interface org.apache.commons.math3.optimization.BaseMultivariateSimpleBoundsOptimizer
Deprecated. Optimize an objective function.
optimize(int, FUNC, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.BaseMultivariateVectorMultiStartOptimizer
Deprecated. Optimize an objective function.
optimize(int, FUNC, double[], double[], double[]) - Method in interface org.apache.commons.math3.optimization.BaseMultivariateVectorOptimizer
Deprecated. As of 3.1. In 4.0, this will be replaced by the declaration corresponding to this method.
optimize(int, FUNC, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. As of 3.1. Please use BaseAbstractMultivariateOptimizer.optimize(int,MultivariateFunction,GoalType,OptimizationData[]) instead.
optimize(int, FUNC, GoalType, OptimizationData...) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. Optimize an objective function.
optimize(int, FUNC, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
Deprecated. Optimize an objective function.
optimize(int, FUNC, GoalType, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateSimpleBoundsOptimizer
Deprecated. Optimize an objective function.
optimize(int, FUNC, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. As of 3.1. Please use BaseAbstractMultivariateVectorOptimizer.optimize(int,MultivariateVectorFunction,OptimizationData[]) instead.
optimize(int, FUNC, OptimizationData...) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Optimize an objective function.
optimize(int, DifferentiableMultivariateVectorFunction, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1. Please use optimize(int,MultivariateDifferentiableVectorFunction,OptimizationData...) instead.
optimize(int, MultivariateDifferentiableVectorFunction, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1. Please use optimize(int,MultivariateDifferentiableVectorFunction,OptimizationData...) instead.
optimize(int, MultivariateDifferentiableFunction, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractScalarDifferentiableOptimizer
Deprecated. Optimize an objective function.
optimize(LinearObjectiveFunction, Collection<LinearConstraint>, GoalType, boolean) - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated. Optimizes an objective function.
optimize(LinearObjectiveFunction, Collection<LinearConstraint>, GoalType, boolean) - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
Deprecated. Optimizes an objective function.
optimize(int, UnivariateFunction, GoalType, double, double, double) - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated. Find an optimum in the given interval, start at startValue.
optimize(int, UnivariateFunction, GoalType, double, double) - Method in class org.apache.commons.math3.optimization.univariate.BaseAbstractUnivariateOptimizer
Deprecated. Find an optimum in the given interval.
optimize(int, FUNC, GoalType, double, double) - Method in interface org.apache.commons.math3.optimization.univariate.BaseUnivariateOptimizer
Deprecated. Find an optimum in the given interval.
optimize(int, FUNC, GoalType, double, double, double) - Method in interface org.apache.commons.math3.optimization.univariate.BaseUnivariateOptimizer
Deprecated. Find an optimum in the given interval, start at startValue.
optimize(int, FUNC, GoalType, double, double) - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated. Find an optimum in the given interval.
optimize(int, FUNC, GoalType, double, double, double) - Method in class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated. Find an optimum in the given interval, start at startValue.
optimizeInternal(int, FUNC, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. As of 3.1. Please use BaseAbstractMultivariateOptimizer.optimize(int,MultivariateFunction,GoalType,OptimizationData[]) instead.
optimizeInternal(int, FUNC, GoalType, OptimizationData...) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateOptimizer
Deprecated. Optimize an objective function.
optimizeInternal(int, FUNC, double[], double[], double[]) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. As of 3.1. Please use BaseAbstractMultivariateVectorOptimizer.optimizeInternal(int,MultivariateVectorFunction,OptimizationData[]) instead.
optimizeInternal(int, FUNC, OptimizationData...) - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Optimize an objective function.
optimizeInternal(int, MultivariateFunction, GoalType, OptimizationData...) - Method in class org.apache.commons.math3.optimization.direct.CMAESOptimizer
Deprecated. Optimize an objective function.
optimizeInternal(int, MultivariateFunction, GoalType, OptimizationData...) - Method in class org.apache.commons.math3.optimization.direct.SimplexOptimizer
Deprecated. Optimize an objective function.
optimizeInternal(int, MultivariateDifferentiableFunction, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractDifferentiableOptimizer
Deprecated. In 3.1. Please use AbstractDifferentiableOptimizer.optimizeInternal(int,MultivariateDifferentiableFunction,GoalType,OptimizationData[]) instead.
optimizeInternal(int, MultivariateDifferentiableFunction, GoalType, OptimizationData...) - Method in class org.apache.commons.math3.optimization.general.AbstractDifferentiableOptimizer
Deprecated. Optimize an objective function.
optimizeInternal(int, MultivariateDifferentiableVectorFunction, OptimizationData...) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1. Override is necessary only until this class's generic argument is changed to MultivariateDifferentiableVectorFunction.
optimizeInternal(int, DifferentiableMultivariateFunction, GoalType, double[]) - Method in class org.apache.commons.math3.optimization.general.AbstractScalarDifferentiableOptimizer
Deprecated. Optimize an objective function.
Orbit - Class in org.orekit.orbits
This class handles orbital parameters.
Orbit(Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.Orbit
Default constructor.
Orbit(PVCoordinates, Frame, AbsoluteDate, double) - Constructor for class org.orekit.orbits.Orbit
Set the orbit from Cartesian parameters.
ORBIT_DIMENSION - Static variable in class org.orekit.propagation.SpacecraftState
First index of the additional states.
orbitAddKeplerContribution(PositionAngle, double, double[]) - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
 
orbitAddKeplerContribution(PositionAngle, double, double[]) - Method in class org.orekit.orbits.ApsisOrbit
Add the contribution of the Keplerian motion to parameters derivatives
orbitAddKeplerContribution(PositionAngle, double, double[]) - Method in class org.orekit.orbits.CartesianOrbit
Add the contribution of the Keplerian motion to parameters derivatives
orbitAddKeplerContribution(PositionAngle, double, double[]) - Method in class org.orekit.orbits.CircularOrbit
Add the contribution of the Keplerian motion to parameters derivatives
orbitAddKeplerContribution(PositionAngle, double, double[]) - Method in class org.orekit.orbits.EquatorialOrbit
Add the contribution of the Keplerian motion to parameters derivatives
orbitAddKeplerContribution(PositionAngle, double, double[]) - Method in class org.orekit.orbits.EquinoctialOrbit
Add the contribution of the Keplerian motion to parameters derivatives
orbitAddKeplerContribution(PositionAngle, double, double[]) - Method in class org.orekit.orbits.KeplerianOrbit
Add the contribution of the Keplerian motion to parameters derivatives
orbitAddKeplerContribution(PositionAngle, double, double[]) - Method in class org.orekit.orbits.Orbit
Add the contribution of the Keplerian motion to parameters derivatives
OrbitCovariance - Class in org.orekit.propagation.analytical.covariance
Class storing orbit covariance and method for coordinate and frame conversion.
OrbitCovariance(AbsoluteDate, Frame, OrbitType, RealMatrix) - Constructor for class org.orekit.propagation.analytical.covariance.OrbitCovariance
Simple constructor
OrbitCovariance(Orbit, OrbitType, RealMatrix) - Constructor for class org.orekit.propagation.analytical.covariance.OrbitCovariance
Simple constructor.
OrbitCovariance(Orbit, RealMatrix) - Constructor for class org.orekit.propagation.analytical.covariance.OrbitCovariance
Simple constructor.
OrbitFile - Interface in org.orekit.files.general
Interface for orbit file representations.
OrbitFile.TimeSystem - Enum in org.orekit.files.general
Time system used throughout this orbit file.
OrbitFileParser - Interface in org.orekit.files.general
Interface for orbit file parsers.
OrbitNatureConverter - Class in fr.cnes.sirius.patrius.stela.orbits
Converts a StelaEquinoctialOrbit from mean to osculating parameters, and reverse.
OrbitNatureConverter(List<StelaForceModel>) - Constructor for class fr.cnes.sirius.patrius.stela.orbits.OrbitNatureConverter
Default constructor.
orbitShiftedBy(double) - Method in class fr.cnes.sirius.patrius.stela.orbits.StelaEquinoctialOrbit
 
orbitShiftedBy(double) - Method in class org.orekit.orbits.ApsisOrbit
Get a time-shifted orbit.
orbitShiftedBy(double) - Method in class org.orekit.orbits.CartesianOrbit
Get a time-shifted orbit.
orbitShiftedBy(double) - Method in class org.orekit.orbits.CircularOrbit
Get a time-shifted orbit.
orbitShiftedBy(double) - Method in class org.orekit.orbits.EquatorialOrbit
Get a time-shifted orbit.
orbitShiftedBy(double) - Method in class org.orekit.orbits.EquinoctialOrbit
Get a time-shifted orbit.
orbitShiftedBy(double) - Method in class org.orekit.orbits.KeplerianOrbit
Get a time-shifted orbit.
orbitShiftedBy(double) - Method in class org.orekit.orbits.Orbit
Get a time-shifted orbit.
OrbitType - Enum in org.orekit.orbits
Enumerate for orbital parameters types.
OrCriterion - Class in fr.cnes.sirius.patrius.events.postprocessing
 
OrCriterion(String, String, String, String) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.OrCriterion
Constructor
OrderedCrossover<T> - Class in org.apache.commons.math3.genetics
Order 1 Crossover [OX1] builds offspring from ordered chromosomes by copying a consecutive slice from one parent, and filling up the remaining genes from the other parent as they appear.
OrderedCrossover() - Constructor for class org.apache.commons.math3.genetics.OrderedCrossover
 
OrderedTuple - Class in org.apache.commons.math3.geometry.partitioning.utilities
This class implements an ordering operation for T-uples.
OrderedTuple(double...) - Constructor for class org.apache.commons.math3.geometry.partitioning.utilities.OrderedTuple
Build an ordered T-uple from its components.
OREKIT_DATA_PATH - Static variable in class org.orekit.data.DataProvidersManager
Name of the property defining the root directories or zip/jar files path for default configuration.
OrekitAddonsMessages - Enum in org.orekit.errors
OREKIT-ADDONS enumeration for localized messages formats.
OrekitConfiguration - Class in org.orekit.utils
Utility class for setting global configuration parameters.
OrekitException - Exception in org.orekit.errors
This class is the base class for all specific exceptions thrown by the orekit classes.
OrekitException(Localizable, Object...) - Constructor for exception org.orekit.errors.OrekitException
Simple constructor.
OrekitException(OrekitException) - Constructor for exception org.orekit.errors.OrekitException
Copy constructor.
OrekitException(Localizable, Throwable) - Constructor for exception org.orekit.errors.OrekitException
Simple constructor.
OrekitException(Throwable, Localizable, Object...) - Constructor for exception org.orekit.errors.OrekitException
Simple constructor.
OrekitException(ExceptionContextProvider) - Constructor for exception org.orekit.errors.OrekitException
Simple constructor.
OrekitExceptionWrapper - Exception in org.orekit.errors
This class allows to wrap OrekitException instances in RuntimeException.
OrekitExceptionWrapper(OrekitException) - Constructor for exception org.orekit.errors.OrekitExceptionWrapper
Simple constructor.
OrekitFixedStepHandler - Interface in org.orekit.propagation.sampling
This interface is a space-dynamics aware fixed size step handler.
OrekitMessages - Enum in org.orekit.errors
Enumeration for localized messages formats.
OrekitRuntimeException - Exception in org.orekit.errors
Orekit Runtime Exception.
OrekitRuntimeException(String, Throwable) - Constructor for exception org.orekit.errors.OrekitRuntimeException
Constructs a new Orekit runtime exception with the specified detail message and cause.
OrekitRuntimeException(Localizable, Throwable) - Constructor for exception org.orekit.errors.OrekitRuntimeException
Constructor with a Localizable specifier instead of a String.
OrekitStepHandler - Interface in org.orekit.propagation.sampling
This interface is a space-dynamics aware step handler.
OrekitStepHandlerMultiplexer - Class in org.orekit.propagation.sampling
This class gathers several OrekitStepHandler instances into one.
OrekitStepHandlerMultiplexer() - Constructor for class org.orekit.propagation.sampling.OrekitStepHandlerMultiplexer
Simple constructor.
OrekitStepInterpolator - Interface in org.orekit.propagation.sampling
This interface is a space-dynamics aware step interpolator.
OrekitStepNormalizer - Class in org.orekit.propagation.sampling
This class wraps an object implementing OrekitFixedStepHandler into a OrekitStepHandler.
OrekitStepNormalizer(double, OrekitFixedStepHandler) - Constructor for class org.orekit.propagation.sampling.OrekitStepNormalizer
Simple constructor.
org.apache.commons.math3 - package org.apache.commons.math3
Common classes used throughout the commons-math library.
org.apache.commons.math3.analysis - package org.apache.commons.math3.analysis
Parent package for common numerical analysis procedures, including root finding, function interpolation and integration.
org.apache.commons.math3.analysis.differentiation - package org.apache.commons.math3.analysis.differentiation
This package holds the main interfaces and basic building block classes dealing with differentiation.
org.apache.commons.math3.analysis.function - package org.apache.commons.math3.analysis.function
The function package contains function objects that wrap the methods contained in Math, as well as common mathematical functions such as the gaussian and sinc functions.
org.apache.commons.math3.analysis.integration - package org.apache.commons.math3.analysis.integration
Numerical integration (quadrature) algorithms for univariate real functions.
org.apache.commons.math3.analysis.integration.gauss - package org.apache.commons.math3.analysis.integration.gauss
Gauss family of quadrature schemes.
org.apache.commons.math3.analysis.interpolation - package org.apache.commons.math3.analysis.interpolation
Univariate real functions interpolation algorithms.
org.apache.commons.math3.analysis.polynomials - package org.apache.commons.math3.analysis.polynomials
Univariate real polynomials implementations, seen as differentiable univariate real functions.
org.apache.commons.math3.analysis.solvers - package org.apache.commons.math3.analysis.solvers
Root finding algorithms, for univariate real functions.
org.apache.commons.math3.complex - package org.apache.commons.math3.complex
Complex number type and implementations of complex transcendental functions.
org.apache.commons.math3.dfp - package org.apache.commons.math3.dfp
Decimal floating point library for Java
org.apache.commons.math3.distribution - package org.apache.commons.math3.distribution
Implementations of common discrete and continuous distributions.
org.apache.commons.math3.exception - package org.apache.commons.math3.exception
Specialized exceptions for algorithms errors.
org.apache.commons.math3.exception.util - package org.apache.commons.math3.exception.util
Classes supporting exception localization.
org.apache.commons.math3.filter - package org.apache.commons.math3.filter
Implementations of common discrete-time linear filters.
org.apache.commons.math3.fitting - package org.apache.commons.math3.fitting
Classes to perform curve fitting.
org.apache.commons.math3.fraction - package org.apache.commons.math3.fraction
Fraction number type and fraction number formatting.
org.apache.commons.math3.genetics - package org.apache.commons.math3.genetics
This package provides Genetic Algorithms components and implementations.
org.apache.commons.math3.geometry - package org.apache.commons.math3.geometry
This package is the top level package for geometry.
org.apache.commons.math3.geometry.euclidean.oned - package org.apache.commons.math3.geometry.euclidean.oned
This package provides basic 1D geometry components.
org.apache.commons.math3.geometry.euclidean.threed - package org.apache.commons.math3.geometry.euclidean.threed
This package provides basic 3D geometry components.
org.apache.commons.math3.geometry.euclidean.twod - package org.apache.commons.math3.geometry.euclidean.twod
This package provides basic 2D geometry components.
org.apache.commons.math3.geometry.partitioning - package org.apache.commons.math3.geometry.partitioning
This package provides classes to implement Binary Space Partition trees.
org.apache.commons.math3.geometry.partitioning.utilities - package org.apache.commons.math3.geometry.partitioning.utilities
This package provides multidimensional ordering features for partitioning.
org.apache.commons.math3.linear - package org.apache.commons.math3.linear
Linear algebra support.
org.apache.commons.math3.ode - package org.apache.commons.math3.ode
This package provides classes to solve Ordinary Differential Equations problems.
org.apache.commons.math3.ode.events - package org.apache.commons.math3.ode.events
This package provides classes to handle discrete events occurring during Ordinary Differential Equations integration.
org.apache.commons.math3.ode.nonstiff - package org.apache.commons.math3.ode.nonstiff
This package provides classes to solve non-stiff Ordinary Differential Equations problems.
org.apache.commons.math3.ode.sampling - package org.apache.commons.math3.ode.sampling
This package provides classes to handle sampling steps during Ordinary Differential Equations integration.
org.apache.commons.math3.optim - package org.apache.commons.math3.optim
Generally, optimizers are algorithms that will either minimize or maximize a scalar function, called the objective function.
org.apache.commons.math3.optim.linear - package org.apache.commons.math3.optim.linear
Optimization algorithms for linear constrained problems.
org.apache.commons.math3.optim.nonlinear.scalar - package org.apache.commons.math3.optim.nonlinear.scalar
Algorithms for optimizing a scalar function.
org.apache.commons.math3.optim.nonlinear.scalar.gradient - package org.apache.commons.math3.optim.nonlinear.scalar.gradient
This package provides optimization algorithms that require derivatives.
org.apache.commons.math3.optim.nonlinear.scalar.noderiv - package org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This package provides optimization algorithms that do not require derivatives.
org.apache.commons.math3.optim.nonlinear.vector - package org.apache.commons.math3.optim.nonlinear.vector
Algorithms for optimizing a vector function.
org.apache.commons.math3.optim.nonlinear.vector.jacobian - package org.apache.commons.math3.optim.nonlinear.vector.jacobian
This package provides optimization algorithms that require derivatives.
org.apache.commons.math3.optim.univariate - package org.apache.commons.math3.optim.univariate
One-dimensional optimization algorithms.
org.apache.commons.math3.optimization - package org.apache.commons.math3.optimization
All classes and sub-packages of this package are deprecated.
org.apache.commons.math3.optimization.direct - package org.apache.commons.math3.optimization.direct
This package provides optimization algorithms that don't require derivatives.
org.apache.commons.math3.optimization.fitting - package org.apache.commons.math3.optimization.fitting
This package provides classes to perform curve fitting.
org.apache.commons.math3.optimization.general - package org.apache.commons.math3.optimization.general
This package provides optimization algorithms that require derivatives.
org.apache.commons.math3.optimization.linear - package org.apache.commons.math3.optimization.linear
This package provides optimization algorithms for linear constrained problems.
org.apache.commons.math3.optimization.univariate - package org.apache.commons.math3.optimization.univariate
Univariate real functions minimum finding algorithms.
org.apache.commons.math3.random - package org.apache.commons.math3.random
Random number and random data generators.
org.apache.commons.math3.special - package org.apache.commons.math3.special
Implementations of special functions such as Beta and Gamma.
org.apache.commons.math3.stat - package org.apache.commons.math3.stat
Data storage, manipulation and summary routines.
org.apache.commons.math3.stat.clustering - package org.apache.commons.math3.stat.clustering
Clustering algorithms
org.apache.commons.math3.stat.correlation - package org.apache.commons.math3.stat.correlation
Correlations/Covariance computations.
org.apache.commons.math3.stat.descriptive - package org.apache.commons.math3.stat.descriptive
Generic univariate summary statistic objects.
org.apache.commons.math3.stat.descriptive.moment - package org.apache.commons.math3.stat.descriptive.moment
Summary statistics based on moments.
org.apache.commons.math3.stat.descriptive.rank - package org.apache.commons.math3.stat.descriptive.rank
Summary statistics based on ranks.
org.apache.commons.math3.stat.descriptive.summary - package org.apache.commons.math3.stat.descriptive.summary
Other summary statistics.
org.apache.commons.math3.stat.inference - package org.apache.commons.math3.stat.inference
Classes providing hypothesis testing and confidence interval construction.
org.apache.commons.math3.stat.ranking - package org.apache.commons.math3.stat.ranking
Classes providing rank transformations.
org.apache.commons.math3.stat.regression - package org.apache.commons.math3.stat.regression
Statistical routines involving multivariate data.
org.apache.commons.math3.transform - package org.apache.commons.math3.transform
Implementations of transform methods, including Fast Fourier transforms.
org.apache.commons.math3.util - package org.apache.commons.math3.util
Convenience routines and common data structures used throughout the commons-math library.
org.apache.commons.math3.utils - package org.apache.commons.math3.utils
 
org.orekit.attitudes - package org.orekit.attitudes
This package provides classes to represent simple attitudes.
org.orekit.attitudes.directions - package org.orekit.attitudes.directions
 
org.orekit.attitudes.kinematics - package org.orekit.attitudes.kinematics
 
org.orekit.bodies - package org.orekit.bodies
This package provides interface to represent the position and geometry of space objects such as stars, planets or asteroids.
org.orekit.data - package org.orekit.data
This package provide base classes for exploring the configured data directory tree and read external data that can be used by the library.
org.orekit.errors - package org.orekit.errors
This package provides classes to generate and handle exceptions.
org.orekit.files.general - package org.orekit.files.general
This package provides interfaces for orbit file representations and corresponding parsers.
org.orekit.files.sp3 - package org.orekit.files.sp3
This package provides a parser for orbit data stored in SP3 format.
org.orekit.forces - package org.orekit.forces
This package provides the interface for force models that will be used by the NumericalPropagator, as well as some classical spacecraft models for surface forces (spherical, box and solar array ...).
org.orekit.forces.atmospheres - package org.orekit.forces.atmospheres
 
org.orekit.forces.atmospheres.MSIS2000 - package org.orekit.forces.atmospheres.MSIS2000
 
org.orekit.forces.atmospheres.solarActivity - package org.orekit.forces.atmospheres.solarActivity
 
org.orekit.forces.atmospheres.solarActivity.specialized - package org.orekit.forces.atmospheres.solarActivity.specialized
 
org.orekit.forces.drag - package org.orekit.forces.drag
 
org.orekit.forces.gravity - package org.orekit.forces.gravity
 
org.orekit.forces.gravity.potential - package org.orekit.forces.gravity.potential
This package provides classes to read gravity field files and supports several different formats.
org.orekit.forces.gravity.tides - package org.orekit.forces.gravity.tides
 
org.orekit.forces.gravity.tides.coefficients - package org.orekit.forces.gravity.tides.coefficients
 
org.orekit.forces.gravity.variations - package org.orekit.forces.gravity.variations
 
org.orekit.forces.gravity.variations.coefficients - package org.orekit.forces.gravity.variations.coefficients
 
org.orekit.forces.maneuvers - package org.orekit.forces.maneuvers
This package provides models of simple maneuvers.
org.orekit.forces.radiation - package org.orekit.forces.radiation
 
org.orekit.forces.relativistic - package org.orekit.forces.relativistic
 
org.orekit.frames - package org.orekit.frames
This package provides classes to handle frames and transforms between them.
org.orekit.frames.configuration - package org.orekit.frames.configuration
 
org.orekit.frames.configuration.eop - package org.orekit.frames.configuration.eop
 
org.orekit.frames.configuration.libration - package org.orekit.frames.configuration.libration
 
org.orekit.frames.configuration.precessionnutation - package org.orekit.frames.configuration.precessionnutation
 
org.orekit.frames.configuration.sp - package org.orekit.frames.configuration.sp
 
org.orekit.frames.configuration.tides - package org.orekit.frames.configuration.tides
 
org.orekit.frames.transformations - package org.orekit.frames.transformations
 
org.orekit.models.earth - package org.orekit.models.earth
This package provides models that simulate certain physical phenomena experienced in the atmosphere of the earth.
org.orekit.orbits - package org.orekit.orbits
This package provides classes to represent orbits.
org.orekit.orbits.orbitalparameters - package org.orekit.orbits.orbitalparameters
 
org.orekit.parameter - package org.orekit.parameter
 
org.orekit.propagation - package org.orekit.propagation
This package provides tools to propagate orbital states with different methods.
org.orekit.propagation.analytical - package org.orekit.propagation.analytical
 
org.orekit.propagation.analytical.covariance - package org.orekit.propagation.analytical.covariance
 
org.orekit.propagation.analytical.tle - package org.orekit.propagation.analytical.tle
This package provides classes to read and extrapolate tle's.
org.orekit.propagation.analytical.twod - package org.orekit.propagation.analytical.twod
 
org.orekit.propagation.events - package org.orekit.propagation.events
This package provides interfaces and classes dealing with events occurring during propagation.
org.orekit.propagation.events.multi - package org.orekit.propagation.events.multi
 
org.orekit.propagation.numerical - package org.orekit.propagation.numerical
 
org.orekit.propagation.precomputed - package org.orekit.propagation.precomputed
 
org.orekit.propagation.sampling - package org.orekit.propagation.sampling
This package provides interfaces and classes dealing with step handling during propagation.
org.orekit.time - package org.orekit.time
This independent package provides classes to handle epochs, time scales, and to compare instants together.
org.orekit.utils - package org.orekit.utils
This package provides useful objects.
org.orekit.wrenches - package org.orekit.wrenches
 
OrientationFrame - Class in org.orekit.attitudes
This class is a special implementation of the Frame class; it represents a dynamic orientation frame, i.e.
OrientationFrame(IOrientationLaw, AttitudeFrame) - Constructor for class org.orekit.attitudes.OrientationFrame
Builds the dynamic orientation frame using AttitudeFrame as the parent frame.
OrientationFrame(IOrientationLaw, OrientationFrame) - Constructor for class org.orekit.attitudes.OrientationFrame
Builds the dynamic orientation frame using OrientationFrame as the parent frame.
OrientationFunction - Interface in org.orekit.attitudes.kinematics
This interface is a time-dependent function representing a generic orientation.
OrientationTransformProvider - Class in org.orekit.attitudes
This class is a TransformProvider for OrientationFrame; it provides, for a given date, the transformation corresponding to the frame orientation with respect to the parent frame.
OrientationTransformProvider(IOrientationLaw, Frame) - Constructor for class org.orekit.attitudes.OrientationTransformProvider
Protected constructor.
OrientedPoint - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents a 1D oriented hyperplane.
OrientedPoint(Vector1D, boolean) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Simple constructor.
OrphanFrame - Class in org.orekit.frames
This class allows creating a frame that is not linked to the Orekit frames tree.
orthogonal() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a vector orthogonal to the instance.
orthogonal() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a vector orthogonal to the instance.
osc2mean(Orbit) - Method in class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Convert provided osculating orbit into mean elements.
osc2mean(Orbit) - Method in class org.orekit.propagation.analytical.LyddaneLongPeriodPropagator
Convert provided osculating orbit into mean elements.
osc2mean(Orbit) - Method in class org.orekit.propagation.analytical.LyddaneSecularPropagator
Convert provided osculating orbit into mean elements.
osc2mean(Orbit) - Method in interface org.orekit.propagation.MeanOsculatingElementsProvider
Convert provided osculating orbit into mean elements.
osculatingDerivative(AbsoluteDate) - Method in class org.orekit.utils.SecularAndHarmonic
Get fitted osculating derivative.
osculatingSecondDerivative(AbsoluteDate) - Method in class org.orekit.utils.SecularAndHarmonic
Get fitted osculating second derivative.
OsculatingToMeanElementsConverter - Class in org.orekit.propagation
This class converts osculating orbital elements into mean elements.
OsculatingToMeanElementsConverter(SpacecraftState, int, Propagator) - Constructor for class org.orekit.propagation.OsculatingToMeanElementsConverter
Constructor.
OsculatingToMeanElementsConverter.NewtonSolverImp - Class in org.orekit.propagation
Specific implementation of the Newton solver.
osculatingValue(AbsoluteDate) - Method in class org.orekit.utils.SecularAndHarmonic
Get fitted osculating value.
outerProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the outer product.
outerProduct(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute the outer product.
outerProduct(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Compute the outer product.
outerProduct(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Compute the outer product.
outerProduct(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Compute the outer product.
outerProduct(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Optimized method to compute outer product when both vectors are sparse.
outerProduct(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Compute the outer product.
OutlineExtractor - Class in org.apache.commons.math3.geometry.euclidean.threed
Extractor for polyhedrons sets outlines.
OutlineExtractor(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.OutlineExtractor
Build an extractor for a specific projection plane.
OutOfRangeException - Exception in org.apache.commons.math3.exception
Exception to be thrown when some argument is out of range.
OutOfRangeException(Number, Number, Number) - Constructor for exception org.apache.commons.math3.exception.OutOfRangeException
Construct an exception from the mismatched dimensions.
OutOfRangeException(Localizable, Number, Number, Number) - Constructor for exception org.apache.commons.math3.exception.OutOfRangeException
Construct an exception from the mismatched dimensions with a specific context information.
Output - Class in org.orekit.forces.atmospheres.MSIS2000
Class Output OUTPUT VARIABLES: d[0] - HE NUMBER DENSITY(CM-3) d[1] - O NUMBER DENSITY(CM-3) d[2] - N2 NUMBER DENSITY(CM-3) d[3] - O2 NUMBER DENSITY(CM-3) d[4] - AR NUMBER DENSITY(CM-3) d[5] - TOTAL MASS DENSITY(GM/CM3) [includes d[8] in td7d] d[6] - H NUMBER DENSITY(CM-3) d[7] - N NUMBER DENSITY(CM-3) d[8] - Anomalous oxygen NUMBER DENSITY(CM-3) t[0] - EXOSPHERIC TEMPERATURE t[1] - TEMPERATURE AT ALT O, H, and N are set to zero below 72.5 km t[0], Exospheric temperature, is set to global average for altitudes below 120 km.
Output() - Constructor for class org.orekit.forces.atmospheres.MSIS2000.Output
Constructor.
overlaps(ComparableInterval<T>) - Method in class org.orekit.utils.ComparableInterval
Returns true when the two intervals overlap.

P

Pair<K,V> - Class in org.apache.commons.math3.util
Generic pair.
Pair(K, V) - Constructor for class org.apache.commons.math3.util.Pair
Create an entry representing a mapping from the specified key to the specified value.
Pair(Pair<? extends K, ? extends V>) - Constructor for class org.apache.commons.math3.util.Pair
Create an entry representing the same mapping as the specified entry.
pairedT(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
pairedT(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
pairedTTest(double[], double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
pairedTTest(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
pairedTTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a paired, two-sample, two-tailed t-test based on the data in the input arrays.
pairedTTest(double[], double[], double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a paired t-test evaluating the null hypothesis that the mean of the paired differences between sample1 and sample2 is 0 in favor of the two-sided alternative that the mean paired difference is not equal to 0, with significance level alpha.
Parallelepiped - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a rectangle parallelepiped shape, with some algorithm to compute intersections and distances to some other objects.
Parallelepiped(Vector3D, Vector3D, Vector3D, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
Build a parallelepiped from the position of its center, two vectors to describe its local frame and dimensions.
ParallelException - Exception in fr.cnes.sirius.validate.parallel
Extends RuntimeException for this package.
ParallelException(String) - Constructor for exception fr.cnes.sirius.validate.parallel.ParallelException
Constructor with message.
ParallelException(Throwable) - Constructor for exception fr.cnes.sirius.validate.parallel.ParallelException
Constructor with cause.
ParallelException(String, Throwable) - Constructor for exception fr.cnes.sirius.validate.parallel.ParallelException
Constructor with message and cause.
ParallelResult - Interface in fr.cnes.sirius.validate.parallel
Holds results for a ParallelTask implementation.
ParallelRunner - Class in fr.cnes.sirius.validate.parallel
Runner for parallel tests written as ParallelTask instances.
ParallelRunner() - Constructor for class fr.cnes.sirius.validate.parallel.ParallelRunner
Default constructor.
ParallelRunner(int) - Constructor for class fr.cnes.sirius.validate.parallel.ParallelRunner
Constructor with thread pool size parameter.
ParallelTask - Interface in fr.cnes.sirius.validate.parallel
A ParallelTask instance is meant to be run once by the ParallelRunner in a multithreaded context.
ParallelTaskFactory<T extends ParallelTask> - Interface in fr.cnes.sirius.validate.parallel
A ParallelTaskFactory is used to create ParallelTask instances.
paramAe - Variable in class org.orekit.forces.gravity.tides.AbstractTides
Equatorial radius parameter.
ParamDiffFunction - Class in org.orekit.parameter
Abstract class to define generic function of IParamDiffFunction.
ParamDiffFunction() - Constructor for class org.orekit.parameter.ParamDiffFunction
 
Parameter - Class in org.orekit.parameter
This class is used to define parameters for finite differences and derivatives of analytic functions computing.
Parameter(String, double) - Constructor for class org.orekit.parameter.Parameter
Constructor with name and value.
Parameterizable - Interface in org.apache.commons.math3.ode
This interface enables to process any parameterizable object.
Parameterizable - Class in org.orekit.parameter
Simple class providing a list and method for handling Parameters.
Parameterizable() - Constructor for class org.orekit.parameter.Parameterizable
Simple constructor.
Parameterizable(Parameter...) - Constructor for class org.orekit.parameter.Parameterizable
Simple constructor.
Parameterizable(ArrayList<Parameter>) - Constructor for class org.orekit.parameter.Parameterizable
Simple constructor.
Parameterizable(IParamDiffFunction...) - Constructor for class org.orekit.parameter.Parameterizable
Simple constructor.
ParameterizedODE - Interface in org.apache.commons.math3.ode
Interface to compute by finite difference Jacobian matrix for some parameter when computing partial derivatives equations.
ParameterJacobianProvider - Interface in org.apache.commons.math3.ode
Interface to compute exactly Jacobian matrix for some parameter when computing partial derivatives equations.
ParametersType - Enum in org.orekit.propagation
Enum class for elements type (mean or osculating).
ParametricUnivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a real function that depends on one independent variable plus some extra parameters.
paramMu - Variable in class org.orekit.forces.gravity.tides.AbstractTides
Central attraction coefficient parameter.
parse(String) - Method in class org.apache.commons.math3.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
Parses a string to produce a BigFraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
Parses a string to produce a BigFraction object.
parse(String) - Method in class org.apache.commons.math3.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
Parses a string to produce a BigFraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
Parses a string to produce a Fraction object.
parse(String) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Parses a string to produce a Vector object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Parses a string to produce a Vector object.
parse(String) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Parses a string to produce a Vector3D object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Parses a string to produce a Vector3D object.
parse(String) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Parses a string to produce a Vector object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Parses a string to produce a Vector object.
parse(String) - Method in class org.apache.commons.math3.geometry.VectorFormat
Parses a string to produce a Vector object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.geometry.VectorFormat
Parses a string to produce a Vector object.
parse(String) - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Parse a string to produce a RealMatrix object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.linear.RealMatrixFormat
Parse a string to produce a RealMatrix object.
parse(String) - Method in class org.apache.commons.math3.linear.RealVectorFormat
Parse a string to produce a RealVector object.
parse(String, ParsePosition) - Method in class org.apache.commons.math3.linear.RealVectorFormat
Parse a string to produce a RealVector object.
parse(InputStream) - Method in interface org.orekit.files.general.OrbitFileParser
Reads an orbit file from the given stream and returns a parsed OrbitFile.
parse(String) - Method in interface org.orekit.files.general.OrbitFileParser
Reads the orbit file and returns a parsed OrbitFile.
parse(String) - Method in class org.orekit.files.sp3.SP3Parser
Reads the orbit file and returns a parsed OrbitFile.
parse(InputStream) - Method in class org.orekit.files.sp3.SP3Parser
Reads an orbit file from the given stream and returns a parsed OrbitFile.
parseAndIgnoreWhitespace(String, ParsePosition) - Static method in class org.apache.commons.math3.fraction.AbstractFormat
Parses source until a non-whitespace character is found.
parseAndIgnoreWhitespace(String, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Parses source until a non-whitespace character is found.
parseCCSDSCalendarSegmentedTimeCode(byte, byte[]) - Static method in class org.orekit.time.AbsoluteDate
Build an instance from a CCSDS Calendar Segmented Time Code (CCS).
parseCCSDSDaySegmentedTimeCode(byte, byte[], DateComponents) - Static method in class org.orekit.time.AbsoluteDate
Build an instance from a CCSDS Day Segmented Time Code (CDS).
parseCCSDSUnsegmentedTimeCode(byte, byte, byte[], AbsoluteDate) - Static method in class org.orekit.time.AbsoluteDate
Build an instance from a CCSDS Unsegmented Time Code (CUC).
parseCoordinates(int, String, ParsePosition) - Method in class org.apache.commons.math3.geometry.VectorFormat
Parses a string to produce an array of coordinates.
parseDate(String) - Static method in class org.orekit.time.DateComponents
Parse a string in ISO-8601 format to build a date.
parseDateTime(String) - Static method in class org.orekit.time.DateTimeComponents
Parse a string in ISO-8601 format to build a date/time.
parseFixedstring(String, String, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Parse source for an expected fixed string.
parseMonth(String) - Static method in enum org.orekit.time.Month
Parse the string to get the month.
parseNextBigInteger(String, ParsePosition) - Method in class org.apache.commons.math3.fraction.BigFractionFormat
Parses a string to produce a BigInteger.
parseNextCharacter(String, ParsePosition) - Static method in class org.apache.commons.math3.fraction.AbstractFormat
Parses source until a non-whitespace character is found.
parseNextCharacter(String, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Parses source until a non-whitespace character is found.
parseNumber(String, NumberFormat, ParsePosition) - Static method in class org.apache.commons.math3.util.CompositeFormat
Parses source for a number.
parseTime(String) - Static method in class org.orekit.time.TimeComponents
Parse a string in ISO-8601 format to build a time.
Part - Class in fr.cnes.sirius.patrius.assembly
-Class to manage the assembly's part (the main part is excluded).
Part(String, IPart, Transform) - Constructor for class fr.cnes.sirius.patrius.assembly.Part
Constructor of a part with a transformation.
partialDerivative(int) - Method in interface org.apache.commons.math3.analysis.DifferentiableMultivariateFunction
Deprecated. Returns the partial derivative of the function with respect to a point coordinate.
PartialDerivativesEquations - Class in org.orekit.propagation.numerical
Set of additional equations computing the partial derivatives of the state (orbit) with respect to initial state and force models parameters.
PartialDerivativesEquations(String, NumericalPropagator) - Constructor for class org.orekit.propagation.numerical.PartialDerivativesEquations
Simple constructor.
partialDerivativeX(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
 
partialDerivativeXX(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
 
partialDerivativeXY(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
 
partialDerivativeY(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
 
partialDerivativeYY(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
 
PascalDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Pascal distribution.
PascalDistribution(int, double) - Constructor for class org.apache.commons.math3.distribution.PascalDistribution
Create a Pascal distribution with the given number of successes and probability of success.
PascalDistribution(RandomGenerator, int, double) - Constructor for class org.apache.commons.math3.distribution.PascalDistribution
Create a Pascal distribution with the given number of successes and probability of success.
PAST_INFINITY - Static variable in class org.orekit.time.AbsoluteDate
Dummy date at infinity in the past direction.
PatriusMessages - Enum in fr.cnes.sirius.patrius.exception.util
Enumeration for localized messages formats used in exceptions messages.
PatriusSolarRadiationPressure - Class in fr.cnes.sirius.patrius.forces.radiation
Solar radiation pressure force model with spheroids.
PatriusSolarRadiationPressure(PVCoordinatesProvider, GeometricBodyShape, RadiationSensitive) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
Simple constructor with default reference values.
PatriusSolarRadiationPressure(PVCoordinatesProvider, GeometricBodyShape, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
Simple constructor with default reference values.
PatriusSolarRadiationPressure(double, double, PVCoordinatesProvider, GeometricBodyShape, RadiationSensitive) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
Complete constructor.
PatriusSolarRadiationPressure(double, double, PVCoordinatesProvider, GeometricBodyShape, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
Complete constructor.
PatriusSolarRadiationPressure(Parameter, PVCoordinatesProvider, GeometricBodyShape, RadiationSensitive) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
Complete constructor using Parameter.
PatriusSolarRadiationPressure(Parameter, PVCoordinatesProvider, GeometricBodyShape, RadiationSensitive, boolean) - Constructor for class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
Complete constructor using Parameter.
PAVGM - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
MIDDLE ATMOSPHERE AVERAGES
PD - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
HE DENSITY
PDL - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
TURBO
PDM - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
PDM
PearsonsCorrelation - Class in org.apache.commons.math3.stat.correlation
Computes Pearson's product-moment correlation coefficients for pairs of arrays or columns of a matrix.
PearsonsCorrelation() - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation instance without data
PearsonsCorrelation(double[][]) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a rectangular array whose columns represent values of variables to be correlated.
PearsonsCorrelation(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a RealMatrix whose columns represent variables to be correlated.
PearsonsCorrelation(Covariance) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a Covariance.
PearsonsCorrelation(RealMatrix, int) - Constructor for class org.apache.commons.math3.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a covariance matrix.
PegasusSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Pegasus method for root-finding (approximating a zero of a univariate real function).
PegasusSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
Construct a solver with default accuracy (1e-6).
PegasusSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
Construct a solver.
PegasusSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
Construct a solver.
PegasusSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.PegasusSolver
Construct a solver.
percentageValue() - Method in class org.apache.commons.math3.fraction.BigFraction
Gets the fraction percentage as a double.
percentageValue() - Method in class org.apache.commons.math3.fraction.Fraction
Gets the fraction percentage as a double.
Percentile - Class in org.apache.commons.math3.stat.descriptive.rank
Provides percentile computation.
Percentile() - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Percentile
Constructs a Percentile with a default quantile value of 50.0.
Percentile(double) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Percentile
Constructs a Percentile with the specific quantile value.
Percentile(Percentile) - Constructor for class org.apache.commons.math3.stat.descriptive.rank.Percentile
Copy constructor, creates a new Percentile identical to the original
percentile(double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns an estimate of the pth percentile of the values in the values array.
percentile(double[], int, int, double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns an estimate of the pth percentile of the values in the values array, starting with the element in (0-based) position begin in the array and including length values.
perige - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
perigee, expressed in KM and ALTITUDE.
PERIGEE - Static variable in class org.orekit.propagation.events.ApsideDetector
Flag for perigee detection (slopeSelection = 0).
PERIGEE_APOGEE - Static variable in class org.orekit.propagation.events.ApsideDetector
Flag for both perigee and apogee detection (slopeSelection = 2).
PerigeeAltitudeDetector - Class in fr.cnes.sirius.patrius.stela
Finder for satellite altitude crossing events in Semi-analytical theory.
PerigeeAltitudeDetector(double, double) - Constructor for class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Build a new altitude detector.
PerigeeAltitudeDetector(double, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Build a new altitude detector.
PerigeeAltitudeDetector(double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Build a new altitude detector.
PerigeeAltitudeDetector(double, double, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Build a new altitude detector.
PerigeeAltitudeDetector(double, double, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Build a new altitude detector.
PerigeeAltitudeDetector(double, double, double, double, OrbitNatureConverter) - Constructor for class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Build a new altitude detector, with osculating perigee.
PerigeeAltitudeDetector(double, double, double, double, OrbitNatureConverter, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Build a new altitude detector, with osculating perigee.
PerigeeAltitudeDetector(double, double, double, double, OrbitNatureConverter, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
Build a new altitude detector, with osculating perigee.
PermutationChromosome<T> - Interface in org.apache.commons.math3.genetics
Interface indicating that the chromosome represents a permutation of objects.
PhenomenaList - Class in fr.cnes.sirius.patrius.events
This class represents a list of objects Phenomenon.
One or more lists of phenomena are created during propagation when CodingEventDetector is used, via the monitorDetector method.
PhenomenaList() - Constructor for class fr.cnes.sirius.patrius.events.PhenomenaList
Default constructor.
Phenomenon - Class in fr.cnes.sirius.patrius.events
This class represents an observable phenomenon.
Phenomenon(CodedEvent, boolean, CodedEvent, boolean, String, String) - Constructor for class fr.cnes.sirius.patrius.events.Phenomenon
Constructor for the Phenomenon instance.
The first and second CodedEvent boundaries can be in any time order.
PhenomenonDurationFilter - Class in fr.cnes.sirius.patrius.events.postprocessing
 
PhenomenonDurationFilter(String, double, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.PhenomenonDurationFilter
Constructor
PhenomenonDurationFilter(List<String>, double, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.PhenomenonDurationFilter
Constructor
PI - Static variable in class org.apache.commons.math3.util.FastMath
Archimede's constant PI, ratio of circle circumference to diameter.
PiecewiseFunction - Class in org.orekit.parameter
This class is used to define parameterizable piecewize function.
PiecewiseFunction(ArrayList<IParamDiffFunction>, ArrayList<AbsoluteDate>) - Constructor for class org.orekit.parameter.PiecewiseFunction
Simple constructor with 2 lists (IParamDiffFunction and AbsoluteDate) where dates list represent the connection points between functions.
Plane - Class in org.apache.commons.math3.geometry.euclidean.threed
The class represent planes in a three dimensional space.
Plane(Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a plane normal to a given direction and containing the origin.
Plane(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a plane from a point and a normal.
Plane(Vector3D, Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a plane from three points.
Plane(Vector3D, Vector3D, Vector3D, boolean) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a plane from a point and two vectors.
Plane(Line, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a plane from a line and a vector.
Plane(Vector3D, Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a plane from a line and a point out of the line.
Plane(Plane) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plane
Copy constructor.
Plate - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D rectangle plate shape, with some algorithm to compute intersections and distances to some other objects.
Plate(Vector3D, Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Plate
Build a plate from the position of its center and two vectors to describe its local frame and dimensions.
PLUS_I - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
First canonical vector (coordinates: 1, 0, 0).
PLUS_J - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Second canonical vector (coordinates: 0, 1, 0).
PLUS_K - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Third canonical vector (coordinates: 0, 0, 1).
PLUTO - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Pluto.
PMA - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
PMA
PN_IERS2003_DIRECT_CONSTANT - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
IERS 2003 without interpolation.
PN_IERS2003_DIRECT_NON_CONSTANT - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
IERS 2003 without interpolation.
PN_IERS2003_INTERPOLATED_CONSTANT - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
IERS 2003 with interpolation.
PN_IERS2003_INTERPOLATED_NON_CONSTANT - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
IERS 2003 with interpolation.
PN_IERS2010_DIRECT_CONSTANT - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
IERS 2010 without interpolation.
PN_IERS2010_DIRECT_NON_CONSTANT - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
IERS 2010 without interpolation.
PN_IERS2010_INTERPOLATED_CONSTANT - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
IERS 2010 with interpolation.
PN_IERS2010_INTERPOLATED_NON_CONSTANT - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
IERS 2010 with interpolation.
PN_STELA - Static variable in class org.orekit.frames.configuration.precessionnutation.PrecessionNutationModelFactory
Stela model.
point - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1.
pointAt(double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get one point from the line.
pointAtDistance(double, double, double) - Method in class org.orekit.frames.TopocentricFrame
Compute the point observed from the station at some specified distance.
PointValuePair - Class in org.apache.commons.math3.optim
This class holds a point and the value of an objective function at that point.
PointValuePair(double[], double) - Constructor for class org.apache.commons.math3.optim.PointValuePair
Builds a point/objective function value pair.
PointValuePair(double[], double, boolean) - Constructor for class org.apache.commons.math3.optim.PointValuePair
Builds a point/objective function value pair.
PointValuePair - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
PointValuePair(double[], double) - Constructor for class org.apache.commons.math3.optimization.PointValuePair
Deprecated. Builds a point/objective function value pair.
PointValuePair(double[], double, boolean) - Constructor for class org.apache.commons.math3.optimization.PointValuePair
Deprecated. Builds a point/objective function value pair.
PointVectorValuePair - Class in org.apache.commons.math3.optim
This class holds a point and the vectorial value of an objective function at that point.
PointVectorValuePair(double[], double[]) - Constructor for class org.apache.commons.math3.optim.PointVectorValuePair
Builds a point/objective function value pair.
PointVectorValuePair(double[], double[], boolean) - Constructor for class org.apache.commons.math3.optim.PointVectorValuePair
Build a point/objective function value pair.
PointVectorValuePair - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
PointVectorValuePair(double[], double[]) - Constructor for class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated. Builds a point/objective function value pair.
PointVectorValuePair(double[], double[], boolean) - Constructor for class org.apache.commons.math3.optimization.PointVectorValuePair
Deprecated. Build a point/objective function value pair.
PoissonDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Poisson distribution.
PoissonDistribution(double) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with specified mean.
PoissonDistribution(double, double, int) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with specified mean, convergence criterion and maximum number of iterations.
PoissonDistribution(RandomGenerator, double, double, int) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with specified mean, convergence criterion and maximum number of iterations.
PoissonDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with the specified mean and convergence criterion.
PoissonDistribution(double, int) - Constructor for class org.apache.commons.math3.distribution.PoissonDistribution
Creates a new Poisson distribution with the specified mean and maximum number of iterations.
PoissonSeries - Class in org.orekit.data
Class representing a Poisson series for nutation or ephemeris computations.
PoissonSeries(InputStream, double, String) - Constructor for class org.orekit.data.PoissonSeries
Build a Poisson series from an IERS table file.
polar2Complex(double, double) - Static method in class org.apache.commons.math3.complex.ComplexUtils
Creates a complex number from the given polar representation.
PolarizationSingleSelection - Class in fr.cnes.sirius.patrius.events.postprocessing
This class is a post processing creation that creates a new polarization single selection phenomenon from two sets of visibility phenomena.
PolarizationSingleSelection(String, String, double, double) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.PolarizationSingleSelection
Builds an instance of PolarizationSingleSelection.
PolarizationSwitch - Class in fr.cnes.sirius.patrius.events.postprocessing
This class is a post processing creation that creates new elements corresponding to polarization switch events.
PolarizationSwitch(String, String, double, double) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.PolarizationSwitch
Builds an instance of PolarizationSwitch.
PolarMotion - Class in org.orekit.frames.configuration
This class contains the different polar motion corrections (libration, tidal effects, sp correction).
PolarMotion(boolean, TidalCorrectionModel, LibrationCorrectionModel, SPrimeModel) - Constructor for class org.orekit.frames.configuration.PolarMotion
Simple constructor.
PoleCorrection - Class in org.orekit.frames.configuration.eop
Simple container class for pole correction parameters.
PoleCorrection(double, double) - Constructor for class org.orekit.frames.configuration.eop.PoleCorrection
Simple constructor.
PolygonsSet - Class in org.apache.commons.math3.geometry.euclidean.twod
This class represents a 2D region: a set of polygons.
PolygonsSet() - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a polygons set representing the whole real line.
PolygonsSet(BSPTree<Euclidean2D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a polygons set from a BSP tree.
PolygonsSet(Collection<SubHyperplane<Euclidean2D>>) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a polygons set from a Boundary REPresentation (B-rep).
PolygonsSet(double, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a parallellepipedic box.
PolygonsSet(double, Vector2D...) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a polygon from a simple list of vertices.
PolygonsSet(Vector2D[][]) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Build a polygons set from a two dimensional array of vertices.
PolyhedronsSet - Class in org.apache.commons.math3.geometry.euclidean.threed
This class represents a 3D region: a set of polyhedrons.
PolyhedronsSet() - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set representing the whole real line.
PolyhedronsSet(BSPTree<Euclidean3D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set from a BSP tree.
PolyhedronsSet(Collection<SubHyperplane<Euclidean3D>>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a polyhedrons set from a Boundary REPresentation (B-rep).
PolyhedronsSet(double, double, double, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Build a parallellepipedic box.
polynomialDerivative() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Returns the first order derivative as a TrigonometricPolynomialFunction.
polynomialDerivative(int) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Returns the nth order derivative as a TrigonometricPolynomialFunction.
polynomialDerivative(FourierSeries) - Static method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Returns the derivative as a TrigonometricPolynomialFunction.
polynomialDerivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns the derivative as a PolynomialFunction.
polynomialDerivative() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Returns the first order derivative as a TrigonometricPolynomialFunction.
polynomialDerivative(int) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Returns the nth order derivative as a TrigonometricPolynomialFunction.
polynomialDerivative(TrigonometricPolynomialFunction) - Static method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Returns the derivative as a TrigonometricPolynomialFunction.
polynomialDerivative() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get first order derivative
polynomialDerivative(TrigonometricPolynomialPrimitive) - Static method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get first order derivative
polynomialDerivative(int) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get nth order derivative
PolynomialFitter - Class in org.apache.commons.math3.fitting
Polynomial fitting is a very simple case of curve fitting.
PolynomialFitter(MultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.fitting.PolynomialFitter
Simple constructor.
PolynomialFitter - Class in org.apache.commons.math3.optimization.fitting
Deprecated. As of 3.1 (to be removed in 4.0).
PolynomialFitter(int, DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated. Since 3.1 (to be removed in 4.0). Please use PolynomialFitter.PolynomialFitter(DifferentiableMultivariateVectorOptimizer) instead.
PolynomialFitter(DifferentiableMultivariateVectorOptimizer) - Constructor for class org.apache.commons.math3.optimization.fitting.PolynomialFitter
Deprecated. Simple constructor.
PolynomialFunction - Class in org.apache.commons.math3.analysis.polynomials
Immutable representation of a real polynomial function with real coefficients.
PolynomialFunction(double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Construct a polynomial with the given coefficients.
PolynomialFunction.Parametric - Class in org.apache.commons.math3.analysis.polynomials
Dedicated parametric polynomial class.
PolynomialFunction.Parametric() - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric
 
PolynomialFunctionLagrangeForm - Class in org.apache.commons.math3.analysis.polynomials
Implements the representation of a real polynomial function in Lagrange Form.
PolynomialFunctionLagrangeForm(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Construct a Lagrange polynomial with the given abscissas and function values.
PolynomialFunctionLagrangeForm(double[], double[][]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Constructs a Lagrange polynomial with the given abscissas and an array of different function values.
PolynomialFunctionNewtonForm - Class in org.apache.commons.math3.analysis.polynomials
Implements the representation of a real polynomial function in Newton Form.
PolynomialFunctionNewtonForm(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Construct a Newton polynomial with the given a[] and c[].
polynomialPrimitive() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Get primitive of FourierSeries.
polynomialPrimitive(FourierSeries) - Static method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Get primitive of FourierSeries.
polynomialPrimitive(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Get primitive of TrigonometricPolynomialFunction
polynomialPrimitive(TrigonometricPolynomialFunction, double) - Static method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Get primitive of TrigonometricPolynomialFunction
PolynomialSolver - Interface in org.apache.commons.math3.analysis.solvers
Interface for (polynomial) root-finding algorithms.
polynomialSplineDerivative() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Get the derivative of the polynomial spline function.
PolynomialSplineFunction - Class in org.apache.commons.math3.analysis.polynomials
Represents a polynomial spline function.
PolynomialSplineFunction(double[], PolynomialFunction[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Construct a polynomial spline function with the given segment delimiters and interpolating polynomials.
PolynomialsUtils - Class in org.apache.commons.math3.analysis.polynomials
A collection of static methods that operate on or return polynomials.
Population - Interface in org.apache.commons.math3.genetics
A collection of chromosomes that facilitates generational evolution.
populationVariance(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the population variance of the entries in the input array, or Double.NaN if the array is empty.
populationVariance(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the population variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
populationVariance(double[], double, int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the population variance of the entries in the specified portion of the input array, using the precomputed mean value.
populationVariance(double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the population variance of the entries in the input array, using the precomputed mean value.
Position - Interface in org.orekit.utils
 
PositionAngle - Enum in org.orekit.orbits
Enumerate for true, eccentric and mean position angles.
POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
A vector with all coordinates set to positive infinity.
POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
A vector with all coordinates set to positive infinity.
POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
A vector with all coordinates set to positive infinity.
POSITIVE_INFINITY - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of Double.POSITIVE_INFINITY as a Decimal64.
positiveOrNull() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is greater than or equal to 0.
positiveSignMeansActive() - Method in interface fr.cnes.sirius.patrius.events.CodingEventDetector
Get the sign of the g method that means "the phenomenon associated to the event is active".
This method has been implemented because of the inconsistency of the sign of the g functions in the EventDetector classes in Orekit: for some events, g is positive when its associated phenomenon is active, and for others, g is positive when its phenomenon is not active.
WARNING : If Phenomena are not supported, the behavior of this method is undefined.
positiveSignMeansActive() - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
positiveSignMeansActive() - Method in interface fr.cnes.sirius.patrius.events.multi.MultiCodingEventDetector
Get the sign of the g method that means "the phenomenon associated to the event is active".
This method has been implemented because of the inconsistency of the sign of the g functions in the MultiEventDetector classes in Patrius: for some events, g is positive when its associated phenomenon is active, and for others, g is positive when its phenomenon is not active.
WARNING : If Phenomena are not supported, the behavior of this method is undefined.
positiveSignMeansActive() - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
PostProcessing - Interface in fr.cnes.sirius.patrius.events.postprocessing
 
PosVelChebyshev - Class in org.orekit.bodies
Position-Velocity model based on Chebyshev polynomials.
PosVelChebyshev(AbsoluteDate, double, double[], double[], double[]) - Constructor for class org.orekit.bodies.PosVelChebyshev
Simple constructor.
PotentialCoefficientsProvider - Interface in org.orekit.forces.gravity.potential
Interface used to provide gravity field coefficients.
PotentialCoefficientsReader - Class in org.orekit.forces.gravity.potential
This abstract class represents a Gravitational Potential Coefficients file reader.
PotentialCoefficientsReader(String, boolean) - Constructor for class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Simple constructor.
PotentialTimeVariations - Interface in org.orekit.forces.gravity.tides
Interface for perturbating forces that moficate the C and S coefficients over the time.
pow(double, DerivativeStructure) - Static method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute ax where a is a double and x a DerivativeStructure
pow(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Power operation.
pow(int) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Integer power operation.
pow(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Power operation.
pow(double, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute power of a double to a derivative structure.
pow(double[], int, double, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute power of a derivative structure.
pow(double[], int, int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute integer power of a derivative structure.
pow(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute power of a derivative structure.
Pow - Class in org.apache.commons.math3.analysis.function
Power function.
Pow() - Constructor for class org.apache.commons.math3.analysis.function.Pow
 
pow(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns of value of this complex number raised to the power of x.
pow(double) - Method in class org.apache.commons.math3.complex.Complex
Returns of value of this complex number raised to the power of x.
pow(Dfp, int) - Static method in class org.apache.commons.math3.dfp.DfpMath
Raises base to the power a by successive squaring.
pow(Dfp, Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
Computes x to the y power.
pow(int) - Method in class org.apache.commons.math3.fraction.BigFraction
Returns a BigFraction whose value is (this<sup>exponent</sup>), returning the result in reduced form.
pow(long) - Method in class org.apache.commons.math3.fraction.BigFraction
Returns a BigFraction whose value is (thisexponent), returning the result in reduced form.
pow(BigInteger) - Method in class org.apache.commons.math3.fraction.BigFraction
Returns a BigFraction whose value is (thisexponent), returning the result in reduced form.
pow(double) - Method in class org.apache.commons.math3.fraction.BigFraction
Returns a double whose value is (thisexponent), returning the result in reduced form.
pow(double) - Method in interface org.apache.commons.math3.RealFieldElement
Power operation.
pow(int) - Method in interface org.apache.commons.math3.RealFieldElement
Integer power operation.
pow(T) - Method in interface org.apache.commons.math3.RealFieldElement
Power operation.
pow(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise an int to an int power.
pow(int, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise an int to a long power.
pow(long, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise a long to an int power.
pow(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise a long to a long power.
pow(BigInteger, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise a BigInteger to an int power.
pow(BigInteger, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise a BigInteger to a long power.
pow(BigInteger, BigInteger) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Raise a BigInteger to a BigInteger power.
pow(double, double) - Static method in class org.apache.commons.math3.util.FastMath
Power function.
pow(double, int) - Static method in class org.apache.commons.math3.util.FastMath
Raise a double to an int power.
PowellOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
Powell algorithm.
PowellOptimizer(double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.PowellOptimizer
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure.
PowellOptimizer(double, double, double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.PowellOptimizer
This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure and the line search tolerances.
PowellOptimizer(double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.PowellOptimizer
The parameters control the default convergence checking procedure.
PowellOptimizer(double, double, double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.PowellOptimizer
Builds an instance with the default convergence checking procedure.
PowellOptimizer - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
PowellOptimizer(double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
Deprecated. This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure.
PowellOptimizer(double, double, double, double, ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
Deprecated. This constructor allows to specify a user-defined convergence checker, in addition to the parameters that control the default convergence checking procedure and the line search tolerances.
PowellOptimizer(double, double) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
Deprecated. The parameters control the default convergence checking procedure.
PowellOptimizer(double, double, double, double) - Constructor for class org.apache.commons.math3.optimization.direct.PowellOptimizer
Deprecated. Builds an instance with the default convergence checking procedure.
Power - Class in org.apache.commons.math3.analysis.function
Power function.
Power(double) - Constructor for class org.apache.commons.math3.analysis.function.Power
 
power(int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the result multiplying this with itself p times.
power(int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of multiplying this with itself p times.
power(int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the result multiplying this with itself p times.
power(int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of multiplying this with itself p times.
power10(int) - Method in class org.apache.commons.math3.dfp.Dfp
Return the specified power of 10.
power10K(int) - Method in class org.apache.commons.math3.dfp.Dfp
Get the specified power of 10000.
PrecessionNutation - Class in org.orekit.frames.configuration
This class contains the precession nutation model used within the FramesConfigurationImplementation class.
PrecessionNutation(boolean, PrecessionNutationModel) - Constructor for class org.orekit.frames.configuration.PrecessionNutation
Constructor.
PrecessionNutationCache - Class in org.orekit.frames.configuration.precessionnutation
Cache for precession nutation correction computation.
PrecessionNutationCache(PrecessionNutationModel, double, int) - Constructor for class org.orekit.frames.configuration.precessionnutation.PrecessionNutationCache
 
PrecessionNutationCache(PrecessionNutationModel) - Constructor for class org.orekit.frames.configuration.precessionnutation.PrecessionNutationCache
 
PrecessionNutationConvention - Enum in org.orekit.frames.configuration.precessionnutation
IERS Precession Nutation enumerate.
PrecessionNutationModel - Interface in org.orekit.frames.configuration.precessionnutation
This interface provides the Celestial Intermediate Pole motion (CIP) in the GCRS, those coordinates are used for the GCRF to CIRF transformation.
PrecessionNutationModelFactory - Class in org.orekit.frames.configuration.precessionnutation
Factory for predefined models.
Precision - Class in org.apache.commons.math3.util
Utilities for comparing numbers.
precondition(double[], double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
Precondition a search direction.
precondition(double[], double[]) - Method in interface org.apache.commons.math3.optim.nonlinear.scalar.gradient.Preconditioner
Precondition a search direction.
precondition(double[], double[]) - Method in class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
Deprecated. Precondition a search direction.
precondition(double[], double[]) - Method in interface org.apache.commons.math3.optimization.general.Preconditioner
Deprecated. Precondition a search direction.
PreconditionedIterativeLinearSolver - Class in org.apache.commons.math3.linear
This abstract class defines preconditioned iterative solvers.
PreconditionedIterativeLinearSolver(int) - Constructor for class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Creates a new instance of this class, with default iteration manager.
PreconditionedIterativeLinearSolver(IterationManager) - Constructor for class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Creates a new instance of this class, with custom iteration manager.
Preconditioner - Interface in org.apache.commons.math3.optim.nonlinear.scalar.gradient
This interface represents a preconditioner for differentiable scalar objective function optimizers.
Preconditioner - Interface in org.apache.commons.math3.optimization.general
Deprecated. As of 3.1 (to be removed in 4.0).
Predefined - Enum in org.orekit.frames
Predefined frames provided by FramesFactory.
predict() - Method in class org.apache.commons.math3.filter.KalmanFilter
Predict the internal state estimation one time step ahead.
predict(double[]) - Method in class org.apache.commons.math3.filter.KalmanFilter
Predict the internal state estimation one time step ahead.
predict(RealVector) - Method in class org.apache.commons.math3.filter.KalmanFilter
Predict the internal state estimation one time step ahead.
predict(double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Returns the "predicted" y value associated with the supplied x value, based on the data that has been added to the model when this method is activated.
PREFIX - Static variable in class fr.cnes.sirius.patrius.assembly.properties.MassEquation
Default prefix for mass equation
preMultiply(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Premultiply this matrix by m.
preMultiply(T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of premultiplying this by m.
preMultiply(double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Premultiply this matrix by m.
preMultiply(T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of premultiplying this by m.
preMultiply(double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
previousIndex - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
At each call, the index is kept.
primitive() - Method in interface org.apache.commons.math3.analysis.IntegrableUnivariateFunction
Returns the primitive of the function
primitive() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Get primitive of TrigonometricPolynomialFunction
primitive() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Get primitive of TrigonometricPolynomialFunction
primitiveValue(double) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Return value at x of the function primitive
probability(double, double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(double) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.BinomialDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(double, double) - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(double, double) - Method in class org.apache.commons.math3.distribution.NormalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 < X <= x1).
probability(int) - Method in class org.apache.commons.math3.distribution.PascalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.PoissonDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(double) - Method in interface org.apache.commons.math3.distribution.RealDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math3.distribution.ZipfDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(double) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
ProcessModel - Interface in org.apache.commons.math3.filter
Defines the process dynamics model for the use with a KalmanFilter.
produceLog() - Method in class fr.cnes.sirius.validate.validationTool.Validate
prints the log in the console and in files.
produceLog(String) - Method in class fr.cnes.sirius.validate.validationTool.Validate
prints the log in the console and in files.
produceReport(URI, URI, URI, URI, URI) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.EphemerisComparator
Produce the report if all the data have been computed above
Product - Class in org.apache.commons.math3.stat.descriptive.summary
Returns the product of the available values.
Product() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Product
Create a Product instance
Product(Product) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Product
Copy constructor, creates a new Product identical to the original
product(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the product of the entries in the input array, or Double.NaN if the array is empty.
product(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
projection(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Find the orthogonal projection of this vector onto another vector.
projection(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Find the orthogonal projection of this vector onto another vector.
ProjectionEllipsoid - Class in fr.cnes.sirius.patrius.projections
This class extends the ExtendedOneAxisEllipsoid class and provides utility methods needed for projections.
ProjectionEllipsoid(double, double, Frame, String) - Constructor for class fr.cnes.sirius.patrius.projections.ProjectionEllipsoid
Constructor for the body ellipsoid.
propagate(AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Propagate towards a target date.
propagate(AbsoluteDate, AbsoluteDate) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Propagate from a start date towards a target date.
propagate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
 
propagate(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
 
propagate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Propagate towards a target date.
propagate(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Propagate from a start date towards a target date.
propagate(AbsoluteDate, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
 
propagate(AbsoluteDate) - Method in class org.orekit.propagation.AbstractPropagator
Propagate towards a target date.
propagate(AbsoluteDate, AbsoluteDate) - Method in class org.orekit.propagation.AbstractPropagator
Propagate from a start date towards a target date.
propagate(Orbit, AbsoluteDate) - Method in class org.orekit.propagation.analytical.covariance.OrbitCovariance
Propagate covariance.
propagate(AbsoluteDate) - Method in class org.orekit.propagation.AnalyticalIntegratedEphemeris
Propagate towards a target date.
propagate(AbsoluteDate, AbsoluteDate) - Method in class org.orekit.propagation.AnalyticalIntegratedEphemeris
Propagate from a start date towards a target date.
propagate(AbsoluteDate) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Propagate towards a target date.
propagate(AbsoluteDate, AbsoluteDate) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Propagate from a start date towards a target date.
propagate(AbsoluteDate) - Method in interface org.orekit.propagation.Propagator
Propagate towards a target date.
propagate(AbsoluteDate, AbsoluteDate) - Method in interface org.orekit.propagation.Propagator
Propagate from a start date towards a target date.
propagateMeanOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.AbstractLyddanePropagator
Propagate mean orbit until provided date.
propagateMeanOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Propagate mean orbit until provided date.
propagateMeanOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.LyddaneSecularPropagator
Propagate mean orbit until provided date.
propagateMeanOrbit(AbsoluteDate) - Method in interface org.orekit.propagation.MeanOsculatingElementsProvider
Propagate mean orbit until provided date.
propagateModel(AbsoluteDate) - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Propagate each parameter model to specified date and return an array of 6 values.
propagateModel(AbsoluteDate, int[]) - Method in class org.orekit.propagation.analytical.twod.Analytical2DOrbitModel
Propagate each parameter model to specified date and return an array of 6 values.
propagateOrbit(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.propagation.PVCoordinatePropagator
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.AbstractPropagator
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.AbstractLyddanePropagator
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate, Orbit, Frame, AbstractLyddanePropagator.LyddaneParametersType) - Method in class org.orekit.propagation.analytical.AbstractLyddanePropagator
Propagate orbit to provided date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.AdapterPropagator
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.J2SecularPropagator
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.KeplerianPropagator
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.tle.TLEPropagator
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.analytical.twod.Analytical2DPropagator
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.AnalyticalIntegratedEphemeris
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
 
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.precomputed.Ephemeris
Extrapolate an orbit up to a specific target date.
propagateOrbit(AbsoluteDate) - Method in class org.orekit.propagation.precomputed.IntegratedEphemeris
Extrapolate an orbit up to a specific target date.
propagateSpacecraftState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Extrapolate a spacecraftState up to a specific target date.
propagateSpacecraftState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
 
PropagationException - Exception in org.orekit.errors
This class is the base class for all specific exceptions thrown by during the propagation computation.
PropagationException(Localizable, Object...) - Constructor for exception org.orekit.errors.PropagationException
Simple constructor.
PropagationException(Throwable, Localizable, Object...) - Constructor for exception org.orekit.errors.PropagationException
Simple constructor.
PropagationException(OrekitException) - Constructor for exception org.orekit.errors.PropagationException
Simple constructor.
PropagationException(ExceptionContextProvider) - Constructor for exception org.orekit.errors.PropagationException
Simple constructor.
propagationManagement(SpacecraftState, double, double, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Manages the current step, method to override when user wants to deal with exceptions during the propagation.
propagationManagement(SpacecraftState, double, double, AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
 
Propagator - Interface in org.orekit.propagation
This interface provides a way to propagate an orbit at any time.
ProperBigFractionFormat - Class in org.apache.commons.math3.fraction
Formats a BigFraction number in proper format.
ProperBigFractionFormat() - Constructor for class org.apache.commons.math3.fraction.ProperBigFractionFormat
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
ProperBigFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperBigFractionFormat
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
ProperBigFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperBigFractionFormat
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
ProperFractionFormat - Class in org.apache.commons.math3.fraction
Formats a Fraction number in proper format.
ProperFractionFormat() - Constructor for class org.apache.commons.math3.fraction.ProperFractionFormat
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math3.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
PropertyType - Enum in fr.cnes.sirius.patrius.assembly
This enumeration lists the possible types of properties that can be added to a part.
providesResidual() - Method in class org.apache.commons.math3.linear.DefaultIterativeLinearSolverEvent
Returns true if IterativeLinearSolverEvent.getResidual() is supported.
providesResidual() - Method in class org.apache.commons.math3.linear.IterativeLinearSolverEvent
Returns true if IterativeLinearSolverEvent.getResidual() is supported.
PS - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
S PARAM
PSimuDataLoader - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This Loader is designed to extract the data from a PSimu formatted ephemeris file.
PSimuDataLoader() - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.PSimuDataLoader
 
PT - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
TEMPERATURE
PTL - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
PTL
PTM - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
LOWER BOUNDARY
put(int, double) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Put a value associated with a key in the map.
put(int, T) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Put a value associated with a key in the map.
put(Integer) - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Add a new orders list for given degree
putTransformer(Class<?>, NumberTransformer) - Method in class org.apache.commons.math3.util.TransformerMap
Sets a Class to Transformer Mapping in the Map.
PV - Interface in org.orekit.utils
 
PVCoordinatePropagator - Class in fr.cnes.sirius.patrius.propagation
This class is an analytical propagator which propagates states from the input PV, Attitude, and additional state provider.
PVCoordinatePropagator(PVCoordinatesProvider, AbsoluteDate, double, Frame) - Constructor for class fr.cnes.sirius.patrius.propagation.PVCoordinatePropagator
Creates an instance of PVCoordinatePropagator without attitude and additional state providers
PVCoordinatePropagator(PVCoordinatesProvider, AbsoluteDate, double, Frame, AttitudeProvider, AttitudeProvider, List<AdditionalStateProvider>) - Constructor for class fr.cnes.sirius.patrius.propagation.PVCoordinatePropagator
Creates an instance of PVCoordinatePropagator with PV, attitude for forces, attitude for events, and additional state providers given by the user.
PVCoordinates - Class in org.orekit.utils
Simple container for Position/Velocity/Acceleration triplets.
PVCoordinates() - Constructor for class org.orekit.utils.PVCoordinates
Simple constructor.
PVCoordinates(Vector3D, Vector3D) - Constructor for class org.orekit.utils.PVCoordinates
Builds a PVCoordinates triplet with zero acceleration.
PVCoordinates(Vector3D, Vector3D, Vector3D) - Constructor for class org.orekit.utils.PVCoordinates
Builds a PVCoordinates triplet.
PVCoordinates(double, PVCoordinates) - Constructor for class org.orekit.utils.PVCoordinates
Multiplicative constructor.
PVCoordinates(PVCoordinates, PVCoordinates) - Constructor for class org.orekit.utils.PVCoordinates
Subtractive constructor.
PVCoordinates(double, PVCoordinates, double, PVCoordinates) - Constructor for class org.orekit.utils.PVCoordinates
Linear constructor.
PVCoordinates(double, PVCoordinates, double, PVCoordinates, double, PVCoordinates) - Constructor for class org.orekit.utils.PVCoordinates
Linear constructor.
PVCoordinates(double, PVCoordinates, double, PVCoordinates, double, PVCoordinates, double, PVCoordinates) - Constructor for class org.orekit.utils.PVCoordinates
Linear constructor.
PVCoordinates(FieldVector3D<DerivativeStructure>) - Constructor for class org.orekit.utils.PVCoordinates
Builds a PVCoordinates triplet from a FieldVector3D<DerivativeStructure>.
PVCoordinatesDPFacade - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class is a facade for the use of PVCoordinates.
PVCoordinatesDPFacade(double[], DataType) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.PVCoordinatesDPFacade
Build an instance from an elapsed duration since to another instant.
PVCoordinatesProvider - Interface in org.orekit.utils
Interface for PV coordinates providers.
PVEphemerisLoader - Class in fr.cnes.sirius.patrius.tools.force.validation
Step by step ephemeris data loader.
PVEphemerisLoader() - Constructor for class fr.cnes.sirius.patrius.tools.force.validation.PVEphemerisLoader
Build an ephemeris data loader.
PyramidalField - Class in fr.cnes.sirius.patrius.fieldsofview
This class describes a pyramidal field of view defined a list of vectors (its edges) cone, to be used in "instruments" part properties.
PyramidalField(String, Vector3D[]) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.PyramidalField
Constructor for a pyramidal field of view.

Q

QNAN - Static variable in class org.apache.commons.math3.dfp.Dfp
Indicator value for quiet NaN.
QRDecomposition - Class in org.apache.commons.math3.linear
Calculates the QR-decomposition of a matrix.
QRDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.QRDecomposition
Calculates the QR-decomposition of the given matrix.
QRDecomposition(RealMatrix, double) - Constructor for class org.apache.commons.math3.linear.QRDecomposition
Calculates the QR-decomposition of the given matrix.
quadraticMean(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the quadratic mean of the entries in the input array, or Double.NaN if the array is empty.
quadraticMean(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the quadratic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
Quaternion - Class in org.apache.commons.math3.complex
This class implements quaternions (Hamilton's hypercomplex numbers).
Quaternion(double, double, double, double) - Constructor for class org.apache.commons.math3.complex.Quaternion
Builds a quaternion from its components.
Quaternion(double, double[]) - Constructor for class org.apache.commons.math3.complex.Quaternion
Builds a quaternion from scalar and vector parts.
Quaternion(double[]) - Constructor for class org.apache.commons.math3.complex.Quaternion
Builds a pure quaternion from a vector (assuming that the scalar part is zero).
QuaternionDPFacade - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class is a facade for the use of quaternions.
QuaternionHarmonicProfile - Class in fr.cnes.sirius.patrius.guidance
Represents a quaternion guidance profile, calculated with Fourier series.
QuaternionHarmonicProfile(AbsoluteDate, Frame, FourierSeries, FourierSeries, FourierSeries, FourierSeries, AbsoluteDateInterval) - Constructor for class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
Create a harmonic, quaternion guidance profile.
QuaternionPolynomialProfile - Class in fr.cnes.sirius.patrius.guidance
Represents a quaternion guidance profile, calculated with polynomial functions
QuaternionPolynomialProfile(Frame, AbsoluteDateInterval, List<QuaternionPolynomialSegment>) - Constructor for class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialProfile
Create a polynomial, quaternion guidance profile.
QuaternionPolynomialSegment - Class in fr.cnes.sirius.patrius.guidance
This class represents a quaternion polynomial guidance profile on a segment.
QuaternionPolynomialSegment(PolynomialFunctionLagrangeForm, PolynomialFunctionLagrangeForm, PolynomialFunctionLagrangeForm, PolynomialFunctionLagrangeForm, AbsoluteDate, AbsoluteDateInterval) - Constructor for class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialSegment
Build a quaternion polynomial guidance profile on a segment.
The polynomial representing the quaternion components are on lagrange form.
QuaternionPolynomialSegment(PolynomialFunction, PolynomialFunction, PolynomialFunction, PolynomialFunction, AbsoluteDate, AbsoluteDateInterval) - Constructor for class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialSegment
Build a quaternion polynomial guidance profile on a segment.
The polynomial representing the quaternion components are generic polynomial functions.

R

R12Loader - Class in fr.cnes.sirius.patrius.signalpropagation.iono
Data loader for the R12 values.
R12Loader(String) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.iono.R12Loader
Constructor.
R12Provider - Interface in fr.cnes.sirius.patrius.signalpropagation.iono
R12 value provider for the Bent model.
RAD_TO_DEG - Static variable in class org.apache.commons.math3.util.MathUtils
180/π.
RADIANS_TO_SEC - Static variable in interface org.orekit.utils.Constants
Conversion factor from radians to seconds: 86400 / 2*PI.
radiationPressureAcceleration(SpacecraftState, Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeModel
Method to compute the radiation pressure acceleration, based on the assembly.
radiationPressureAcceleration(SpacecraftState, Vector3D) - Method in interface org.orekit.forces.radiation.RadiationSensitive
Compute the acceleration due to radiation pressure.
RadiationSensitive - Interface in org.orekit.forces.radiation
Interface for spacecraft that are sensitive to radiation pressure forces.
radiationWrench(SpacecraftState, Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeWrenchModel
Compute the torque due to radiation pressire.
radiationWrench(SpacecraftState, Vector3D, Vector3D, Frame) - Method in class fr.cnes.sirius.patrius.assembly.models.DirectRadiativeWrenchModel
Compute the torque due to radiation pressire.
radiationWrench(SpacecraftState, Vector3D) - Method in interface fr.cnes.sirius.patrius.wrenches.RadiationWrenchSensitive
Compute the torque due to radiation pressire.
radiationWrench(SpacecraftState, Vector3D, Vector3D, Frame) - Method in interface fr.cnes.sirius.patrius.wrenches.RadiationWrenchSensitive
Compute the torque due to radiation pressire.
RadiationWrenchSensitive - Interface in fr.cnes.sirius.patrius.wrenches
Interface to represent solar radiation wrench sensitive vehicles
RadiativeApplicationPoint - Class in fr.cnes.sirius.patrius.assembly.properties
This class represents a radiative application point property
RadiativeApplicationPoint(Vector3D) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.RadiativeApplicationPoint
Create a radiative force application point property.
RadiativeFacetProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is a part property for the PATRIUS assembly.
RadiativeFacetProperty(Facet) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.RadiativeFacetProperty
Constructor of this property.
RadiativeIRProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is a part property for the PATRIUS assembly.
RadiativeIRProperty(double, double, double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
Constructor of this property.
RadiativeIRProperty(Parameter, Parameter, Parameter) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.RadiativeIRProperty
Constructor of this property using Parameter.
RadiativeProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is a part property for the PATRIUS assembly.
RadiativeProperty(double, double, double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
Constructor of this property.
RadiativeProperty(Parameter, Parameter, Parameter) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.RadiativeProperty
Constructor of this property using Parameter.
RadiativeSphereProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class is a part property for the PATRIUS assembly.
RadiativeSphereProperty(double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.RadiativeSphereProperty
Constructor with radius.
RadiativeSphereProperty(Parameter) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.RadiativeSphereProperty
Constructor with area.
RADIUS - Static variable in class org.orekit.forces.gravity.BalminoAttractionModel
Parameter name for equatorial radius.
RADIUS - Static variable in class org.orekit.forces.gravity.CunninghamAttractionModel
Parameter name for equatorial radius.
RADIUS - Static variable in class org.orekit.forces.gravity.DrozinerAttractionModel
Parameter name for equatorial radius.
RADIUS - Static variable in class org.orekit.forces.gravity.tides.AbstractTides
Parameter name for equatorial radius.
RADIUS - Static variable in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Parameter name for equatorial radius.
RADIX - Static variable in class org.apache.commons.math3.dfp.Dfp
The radix, or base of this system.
random - Variable in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
RNG instance used to generate samples from the distribution.
random - Variable in class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
RNG instance used to generate samples from the distribution.
random - Variable in class org.apache.commons.math3.distribution.AbstractRealDistribution
RNG instance used to generate samples from the distribution.
random() - Static method in class org.apache.commons.math3.util.FastMath
Returns a pseudo-random number between 0.0 and 1.0.
RandomAdaptor - Class in org.apache.commons.math3.random
Extension of java.util.Random wrapping a RandomGenerator.
RandomAdaptor(RandomGenerator) - Constructor for class org.apache.commons.math3.random.RandomAdaptor
Construct a RandomAdaptor wrapping the supplied RandomGenerator.
randomBinaryRepresentation(int) - Static method in class org.apache.commons.math3.genetics.BinaryChromosome
Returns a representation of a random binary array of length length.
randomData - Variable in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Deprecated. As of 3.1, to be removed in 4.0. Please use the AbstractIntegerDistribution.random instance variable instead.
randomData - Variable in class org.apache.commons.math3.distribution.AbstractRealDistribution
Deprecated. As of 3.1, to be removed in 4.0. Please use the AbstractRealDistribution.random instance variable instead.
RandomData - Interface in org.apache.commons.math3.random
Deprecated. to be removed in 4.0. Use RandomDataGenerator directly
RandomDataGenerator - Class in org.apache.commons.math3.random
Implements the RandomData interface using a RandomGenerator instance to generate non-secure data and a SecureRandom instance to provide data for the nextSecureXxx methods.
RandomDataGenerator() - Constructor for class org.apache.commons.math3.random.RandomDataGenerator
Construct a RandomDataGenerator, using a default random generator as the source of randomness.
RandomDataGenerator(RandomGenerator) - Constructor for class org.apache.commons.math3.random.RandomDataGenerator
Construct a RandomDataGenerator using the supplied RandomGenerator as the source of (non-secure) random data.
RandomDataImpl - Class in org.apache.commons.math3.random
Deprecated. to be removed in 4.0. Use RandomDataGenerator instead
RandomDataImpl() - Constructor for class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Construct a RandomDataImpl, using a default random generator as the source of randomness.
RandomDataImpl(RandomGenerator) - Constructor for class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Construct a RandomDataImpl using the supplied RandomGenerator as the source of (non-secure) random data.
RandomGenerator - Interface in org.apache.commons.math3.random
Interface extracted from java.util.Random.
RandomKey<T> - Class in org.apache.commons.math3.genetics
Random Key chromosome is used for permutation representation.
RandomKey(List<Double>) - Constructor for class org.apache.commons.math3.genetics.RandomKey
Constructor.
RandomKey(Double[]) - Constructor for class org.apache.commons.math3.genetics.RandomKey
Constructor.
RandomKeyMutation - Class in org.apache.commons.math3.genetics
Mutation operator for RandomKeys.
RandomKeyMutation() - Constructor for class org.apache.commons.math3.genetics.RandomKeyMutation
 
randomPermutation(int) - Static method in class org.apache.commons.math3.genetics.RandomKey
Generates a representation corresponding to a random permutation of length l which can be passed to the RandomKey constructor.
RandomVectorGenerator - Interface in org.apache.commons.math3.random
This interface represents a random generator for whole vectors.
rank(double[]) - Method in class org.apache.commons.math3.stat.ranking.NaturalRanking
Rank data using the natural ordering on Doubles, with NaN values handled according to nanStrategy and ties resolved using tiesStrategy.
rank(double[]) - Method in interface org.apache.commons.math3.stat.ranking.RankingAlgorithm
Performs a rank transformation on the input data, returning an array of ranks.
RankingAlgorithm - Interface in org.apache.commons.math3.stat.ranking
Interface representing a rank transformation.
RAPID_DATA_PREDICITON_COLUMNS_1980_FILENAME - Static variable in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Default regular expression for the Rapid Data and Prediction EOP columns files (IAU1980 compatibles).
RAPID_DATA_PREDICITON_COLUMNS_2000_FILENAME - Static variable in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Default regular expression for the Rapid Data and Prediction EOP columns files (IAU2000 compatibles).
RAPID_DATA_PREDICITON_XML_1980_FILENAME - Static variable in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Default regular expression for the Rapid Data and Prediction EOP XML files (IAU1980 compatibles).
RAPID_DATA_PREDICITON_XML_2000_FILENAME - Static variable in class org.orekit.frames.configuration.eop.EOPHistoryFactory
Default regular expression for the Rapid Data and Prediction EOP XML files (IAU2000 compatibles).
RapidDataAndPredictionColumnsLoader - Class in org.orekit.frames.configuration.eop
Loader for IERS rapid data and prediction files in columns format (finals file).
RapidDataAndPredictionColumnsLoader(String) - Constructor for class org.orekit.frames.configuration.eop.RapidDataAndPredictionColumnsLoader
Build a loader for IERS bulletins B files.
RapidDataAndPredictionXMLLoader - Class in org.orekit.frames.configuration.eop
Loader for IERS rapid data and prediction file in XML format (finals file).
RapidDataAndPredictionXMLLoader(String) - Constructor for class org.orekit.frames.configuration.eop.RapidDataAndPredictionXMLLoader
Build a loader for IERS XML EOP files.
RawDataComparator - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
this class is used to compare two sets of data, possibly using thresholds.
RawDataComparator() - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.RawDataComparator
 
readBaseExternal(ObjectInput) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Read the base state of the instance.
readCompleted - Variable in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Indicator for completed read.
readCompleted - Variable in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Indicator for completed read.
readCompleted - Variable in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Indicator for completed read.
readExternal(ObjectInput) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
readExternal(ObjectInput) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
readResolve() - Method in class org.apache.commons.math3.complex.Complex
Resolve the transient fields in a deserialized Complex Object.
RealDistribution - Interface in org.apache.commons.math3.distribution
Base interface for distributions on the reals.
RealFieldElement<T> - Interface in org.apache.commons.math3
Interface representing a real field.
RealLinearOperator - Class in org.apache.commons.math3.linear
This class defines a linear operator operating on real (double) vector spaces.
RealLinearOperator() - Constructor for class org.apache.commons.math3.linear.RealLinearOperator
 
RealMatrix - Interface in org.apache.commons.math3.linear
Interface defining a real-valued matrix with basic algebraic operations.
RealMatrixChangingVisitor - Interface in org.apache.commons.math3.linear
Interface defining a visitor for matrix entries.
RealMatrixFormat - Class in org.apache.commons.math3.linear
Formats a nxm matrix in components list format "{{a00,a01, ..., a0m-1},{a10, a11, ..., a1m-1},{...},{ an-10, an-11, ..., an-1m-1}}".
RealMatrixFormat() - Constructor for class org.apache.commons.math3.linear.RealMatrixFormat
Create an instance with default settings.
RealMatrixFormat(NumberFormat) - Constructor for class org.apache.commons.math3.linear.RealMatrixFormat
Create an instance with a custom number format for components.
RealMatrixFormat(String, String, String, String, String, String) - Constructor for class org.apache.commons.math3.linear.RealMatrixFormat
Create an instance with custom prefix, suffix and separator.
RealMatrixFormat(String, String, String, String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.linear.RealMatrixFormat
Create an instance with custom prefix, suffix, separator and format for components.
RealMatrixPreservingVisitor - Interface in org.apache.commons.math3.linear
Interface defining a visitor for matrix entries.
RealTransformer - Interface in org.apache.commons.math3.transform
Interface for one-dimensional data sets transformations producing real results.
RealVector - Class in org.apache.commons.math3.linear
Class defining a real-valued vector with basic algebraic operations.
RealVector() - Constructor for class org.apache.commons.math3.linear.RealVector
 
RealVector.Entry - Class in org.apache.commons.math3.linear
An entry in the vector.
RealVector.Entry() - Constructor for class org.apache.commons.math3.linear.RealVector.Entry
Simple constructor.
RealVector.SparseEntryIterator - Class in org.apache.commons.math3.linear
Deprecated. As of 3.1, this class is deprecated, see JIRA MATH-875. This class will be completely removed in 4.0.
RealVector.SparseEntryIterator() - Constructor for class org.apache.commons.math3.linear.RealVector.SparseEntryIterator
Deprecated. Simple constructor.
RealVectorChangingVisitor - Interface in org.apache.commons.math3.linear
This interface defines a visitor for the entries of a vector.
RealVectorFormat - Class in org.apache.commons.math3.linear
Formats a vector in components list format "{v0; v1; ...; vk-1}".
RealVectorFormat() - Constructor for class org.apache.commons.math3.linear.RealVectorFormat
Create an instance with default settings.
RealVectorFormat(NumberFormat) - Constructor for class org.apache.commons.math3.linear.RealVectorFormat
Create an instance with a custom number format for components.
RealVectorFormat(String, String, String) - Constructor for class org.apache.commons.math3.linear.RealVectorFormat
Create an instance with custom prefix, suffix and separator.
RealVectorFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.linear.RealVectorFormat
Create an instance with custom prefix, suffix, separator and format for components.
RealVectorPreservingVisitor - Interface in org.apache.commons.math3.linear
This interface defines a visitor for the entries of a vector.
reciprocal() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.complex.Complex
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.dfp.Dfp
Returns the multiplicative inverse of this element.
reciprocal() - Method in interface org.apache.commons.math3.FieldElement
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.fraction.BigFraction
Return the multiplicative inverse of this fraction.
reciprocal() - Method in class org.apache.commons.math3.fraction.Fraction
Return the multiplicative inverse of this fraction.
reciprocal() - Method in interface org.apache.commons.math3.RealFieldElement
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.util.BigReal
Returns the multiplicative inverse of this element.
reciprocal() - Method in class org.apache.commons.math3.util.Decimal64
Returns the multiplicative inverse of this element.
RecordSegmentSearchIndex - Class in org.apache.commons.math3.utils
Search index algorithm with previous index computation storage.
RecordSegmentSearchIndex(ISearchIndex) - Constructor for class org.apache.commons.math3.utils.RecordSegmentSearchIndex
Constructor of search index class with memorization of the last found index in order to optimize the search and find the index quickly if it belongs to a close neighborhood of the last one (+/- 2 points).
RectangleCone - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D rectangle cone ended by a plane normal to its axis (pyramid), with some algorithm to compute intersections and distances to some other objects.
RectangleCone(Vector3D, Vector3D, Vector3D, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
Build a rectangle cone from its apex (origin), axis' direction, approximative U vector of the local frame and dimensions.
RectangleField - Class in fr.cnes.sirius.patrius.fieldsofview
This class describes a field of view defined by a rectangle cone, to be used in "instruments" part properties.
RectangleField(String, Vector3D, Vector3D, double, double) - Constructor for class fr.cnes.sirius.patrius.fieldsofview.RectangleField
Constructor for a field of view defined by a rectangle cone.
RectangularCholeskyDecomposition - Class in org.apache.commons.math3.linear
Calculates the rectangular Cholesky decomposition of a matrix.
RectangularCholeskyDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
Decompose a symmetric positive semidefinite matrix.
RectangularCholeskyDecomposition(RealMatrix, double) - Constructor for class org.apache.commons.math3.linear.RectangularCholeskyDecomposition
Decompose a symmetric positive semidefinite matrix.
RediffusedFlux - Class in org.orekit.forces.radiation
creating a set of solar pressure rediffused by the earth for a satellite position.
RediffusedFlux(int, int, Frame, CelestialBody, PVCoordinatesProvider, AbsoluteDate, IEmissivityModel) - Constructor for class org.orekit.forces.radiation.RediffusedFlux
Default constructor of rediffused flux.
RediffusedFlux(int, int, Frame, CelestialBody, PVCoordinatesProvider, AbsoluteDate, IEmissivityModel, boolean, boolean) - Constructor for class org.orekit.forces.radiation.RediffusedFlux
Generic constructor of rediffused flux.
RediffusedRadiationPressure - Class in org.orekit.forces.radiation
Class that represents a rediffused radiative force.
RediffusedRadiationPressure(CelestialBody, Frame, int, int, IEmissivityModel, RediffusedRadiationSensitive) - Constructor for class org.orekit.forces.radiation.RediffusedRadiationPressure
Constructor.
RediffusedRadiationPressure(CelestialBody, Frame, int, int, IEmissivityModel, RediffusedRadiationSensitive, boolean) - Constructor for class org.orekit.forces.radiation.RediffusedRadiationPressure
Constructor.
rediffusedRadiationPressureAcceleration(SpacecraftState, ElementaryFlux) - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
Method to compute the rediffused radiation pressure acceleration, based on the assembly.
rediffusedRadiationPressureAcceleration(SpacecraftState, ElementaryFlux) - Method in interface org.orekit.forces.radiation.RediffusedRadiationSensitive
rediffused radiative pressure acceleration
RediffusedRadiationSensitive - Interface in org.orekit.forces.radiation
rediffused radiative pressure interface
RediffusedRadiativeModel - Class in fr.cnes.sirius.patrius.assembly.models
Class that represents a rediffused radiative model, based on the vehicle.
RediffusedRadiativeModel(boolean, boolean, double, double, Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
Rediffused radiative model (the acceleration is computed from all the sub parts of the vehicle).
RediffusedRadiativeModel(boolean, boolean, Parameter, Parameter, Assembly) - Constructor for class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
Rediffused radiative model (the acceleration is computed from all the sub parts of the vehicle).
reduce() - Method in class org.apache.commons.math3.fraction.BigFraction
Reduce this BigFraction to its lowest terms.
reduce(double, double, double) - Static method in class org.apache.commons.math3.util.MathUtils
Reduce |a - offset| to the primary interval [0, |period|).
ReentryParameters - Class in org.orekit.orbits.orbitalparameters
This class handles reentry parameters.
ReentryParameters(double, double, double, double, double, double, double, double, double) - Constructor for class org.orekit.orbits.orbitalparameters.ReentryParameters
Constructor.
REFDAY - Static variable in class org.orekit.forces.radiation.KnockeRiesModel
reference day of Knocke-Ries model.
REFERENCE_FLUX - Static variable in class fr.cnes.sirius.patrius.forces.radiation.PatriusSolarRadiationPressure
Normalized reference flux.
REFERENCE_FLUX - Static variable in class org.orekit.forces.radiation.SolarRadiationPressure
Normalized reference flux.
ReferencePointsDisplacement - Class in org.orekit.utils
This class provides the model describing the displacements of reference points due to the effect of the solid Earth tides.
Region<S extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface represents a region of a space as a partition.
Region.Location - Enum in org.apache.commons.math3.geometry.partitioning
Enumerate for the location of a point with respect to the region.
RegionFactory<S extends Space> - Class in org.apache.commons.math3.geometry.partitioning
This class is a factory for Region.
RegionFactory() - Constructor for class org.apache.commons.math3.geometry.partitioning.RegionFactory
Simple constructor.
registerSwitchEvents(Propagator) - Method in class org.orekit.attitudes.AttitudesSequence
Register all wrapped switch events to the propagator.
registerVariationalEquations(ExpandableStatefulODE) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Register the variational equations for the Jacobians matrices to the expandable set.
regress() - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Conducts a regression on the data in the model, using all regressors.
regress(int) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Conducts a regression on the data in the model, using a subset of regressors.
regress(int[]) - Method in class org.apache.commons.math3.stat.regression.MillerUpdatingRegression
Conducts a regression on the data in the model, using regressors in array Calling this method will change the internal order of the regressors and care is required in interpreting the hatmatrix.
regress() - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Performs a regression on data present in buffers and outputs a RegressionResults object.
regress(int[]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Performs a regression on data present in buffers including only regressors indexed in variablesToInclude and outputs a RegressionResults object
regress() - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Performs a regression on data present in buffers and outputs a RegressionResults object
regress(int[]) - Method in interface org.apache.commons.math3.stat.regression.UpdatingMultipleLinearRegression
Performs a regression on data present in buffers including only regressors indexed in variablesToInclude and outputs a RegressionResults object
RegressionResults - Class in org.apache.commons.math3.stat.regression
Results of a Multiple Linear Regression model fit.
RegressionResults(double[], double[][], boolean, long, int, double, double, double, boolean, boolean) - Constructor for class org.apache.commons.math3.stat.regression.RegressionResults
Constructor for Regression Results.
RegulaFalsiSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Regula Falsi or False position method for root-finding (approximating a zero of a univariate real function).
RegulaFalsiSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.RegulaFalsiSolver
Construct a solver with default accuracy (1e-6).
RegulaFalsiSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.RegulaFalsiSolver
Construct a solver.
RegulaFalsiSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.RegulaFalsiSolver
Construct a solver.
RegulaFalsiSolver(double, double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.RegulaFalsiSolver
Construct a solver.
regularizedBeta(double, double, double) - Static method in class org.apache.commons.math3.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, double) - Static method in class org.apache.commons.math3.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, int) - Static method in class org.apache.commons.math3.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, double, int) - Static method in class org.apache.commons.math3.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedGammaP(double, double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the regularized gamma function P(a, x).
regularizedGammaP(double, double, double, int) - Static method in class org.apache.commons.math3.special.Gamma
Returns the regularized gamma function P(a, x).
regularizedGammaQ(double, double) - Static method in class org.apache.commons.math3.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
regularizedGammaQ(double, double, double, int) - Static method in class org.apache.commons.math3.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
reinitialize(double[], boolean, EquationsMapper, EquationsMapper[]) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Reinitialize the instance
reinitialize(double[], boolean, EquationsMapper, EquationsMapper[]) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Reinitialize the instance.
reinitialize(double, double, double[], Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Reinitialize the instance.
reinitializeBegin(StepInterpolator) - Method in class org.apache.commons.math3.ode.events.EventState
Reinitialize the beginning of the step.
reinitializeBegin(SpacecraftState) - Method in class org.orekit.propagation.events.EventState
Reinitialize the beginning of the step.
reinitializeFrame() - Method in interface fr.cnes.sirius.patrius.assembly.IPart
Reinitialize the part's frame with the same Transform.
reinitializeFrame() - Method in class fr.cnes.sirius.patrius.assembly.MainPart
This method implements no action for the main part.
reinitializeFrame() - Method in class fr.cnes.sirius.patrius.assembly.Part
 
Relationship - Enum in org.apache.commons.math3.optim.linear
Types of relationships between two cells in a Solver LinearConstraint.
Relationship - Enum in org.apache.commons.math3.optimization.linear
Deprecated. As of 3.1 (to be removed in 4.0).
RelativeTabulatedAttitudeLaw - Class in org.orekit.attitudes
This class represents a relative tabulated attitude law version "attitudeLeg", with an interval of validity (whose borders are closed points) and attitude laws outside this interval of validity, which can be of two types : a ConstantAttitudeLaw, or an ExtrapolatedAttitudeLaw (private class)
RelativeTabulatedAttitudeLaw(Frame, AbsoluteDate, List<Pair<Double, Rotation>>, RelativeTabulatedAttitudeLaw.AroundAttitudeType, RelativeTabulatedAttitudeLaw.AroundAttitudeType) - Constructor for class org.orekit.attitudes.RelativeTabulatedAttitudeLaw
Create a RelativeTabulatedAttitudeLaw object with list of rotations (during the interval of validity), a law before the interval and a law after the interval.
RelativeTabulatedAttitudeLaw(AbsoluteDate, List<Pair<Double, AngularCoordinates>>, Frame, RelativeTabulatedAttitudeLaw.AroundAttitudeType, RelativeTabulatedAttitudeLaw.AroundAttitudeType) - Constructor for class org.orekit.attitudes.RelativeTabulatedAttitudeLaw
Create a RelativeTabulatedAttitudeLaw object with list of Angular Coordinates (during the interval of validity), a law before the interval and a law after the interval.
RelativeTabulatedAttitudeLaw.AroundAttitudeType - Enum in org.orekit.attitudes
Enumeration of the existing constraint types
RelativeTabulatedAttitudeLeg - Class in org.orekit.attitudes
This class implements the tabulated attitude leg relative to a reference date.
RelativeTabulatedAttitudeLeg(AbsoluteDate, List<Pair<Double, Rotation>>, Frame) - Constructor for class org.orekit.attitudes.RelativeTabulatedAttitudeLeg
Build a RelativeTabulatedAttitudeLeg with a reference date, a list of Rotations associated with a double representing the time elapsed since the reference date.
RelativeTabulatedAttitudeLeg(AbsoluteDate, List<Pair<Double, Rotation>>, Frame, int) - Constructor for class org.orekit.attitudes.RelativeTabulatedAttitudeLeg
Build a RelativeTabulatedAttitudeLeg with a reference date, a list of Rotations associated with a double representing the time elapsed since the reference date and a number of points used for interpolation.
RelativeTabulatedAttitudeLeg(AbsoluteDate, Frame, List<Pair<Double, AngularCoordinates>>) - Constructor for class org.orekit.attitudes.RelativeTabulatedAttitudeLeg
Build a RelativeTabulatedAttitudeLeg with a reference date, a list of angular coordinates associated with a double representing the time elapsed since the reference date.
RelativeTabulatedAttitudeLeg(AbsoluteDate, List<Pair<Double, AngularCoordinates>>, int, Frame) - Constructor for class org.orekit.attitudes.RelativeTabulatedAttitudeLeg
Build a RelativeTabulatedAttitudeLeg with a reference date, a list of angular coordinates associated with a double representing the time elapsed since the reference date and a number of points used for interpolation.
remainder(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'%' operator.
remainder(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'%' operator.
remainder(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform remainder of two derivative structures.
remainder(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Returns the IEEE remainder.
remainder(double) - Method in interface org.apache.commons.math3.RealFieldElement
IEEE remainder operator.
remainder(T) - Method in interface org.apache.commons.math3.RealFieldElement
IEEE remainder operator.
remove(CodedEvent) - Method in class fr.cnes.sirius.patrius.events.CodedEventsList
Remove a CodedEvent to the list.
remove(Phenomenon) - Method in class fr.cnes.sirius.patrius.events.PhenomenaList
Remove a Phenomenon to the list.
remove(ConstantThrustManeuver) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
Remove the selected continue maneuver with constant thrust from the list.
If the maneuver is not in the list, it returns false.
remove(VariableThrustManeuver) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
Remove the selected continue maneuver with variable thrust from the list.
If the maneuver is not in the list, it returns false.
remove(ImpulseManeuver) - Method in class fr.cnes.sirius.patrius.forces.maneuvers.ManeuversSequence
Remove the selected impulse maneuver from the list.
If the maneuver is not in the list, it returns false.
remove() - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapSparseIterator
Deprecated. 
remove() - Method in class org.apache.commons.math3.linear.RealVector.SparseEntryIterator
Deprecated. 
remove() - Method in class org.apache.commons.math3.util.MultidimensionalCounter.Iterator
 
remove(int) - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Remove the value associated with a key.
remove(int) - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Remove the value associated with a key.
removeCodedEvent(CodedEvent) - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
 
REMOVED - Static variable in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Status indicator for removed table entries.
REMOVED - Static variable in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Status indicator for removed table entries.
removeData(double, double) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Removes the observation (x,y) from the regression data set.
removeData(double[][]) - Method in class org.apache.commons.math3.stat.regression.SimpleRegression
Removes observations represented by the elements in data.
removeDetector() - Method in class org.apache.commons.math3.ode.events.EventState
Check the current detector should be removed at the end of the current step current step.
removeDetector() - Method in class org.orekit.propagation.events.EventState
Check if the current detector should be removed at the end of the current step.
removeForceModels() - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Remove all perturbing force models from the global perturbation model.
removeForceModels() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Remove all perturbing force models from the global perturbation model.
removeForceModels() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Remove all perturbing force models from the global perturbation model.
removeIterationListener(IterationListener) - Method in class org.apache.commons.math3.util.IterationManager
Removes the specified iteration listener from the list of listeners currently attached to this object.
removeMostRecentValue() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Removes the most recent value from the dataset.
removeOnlyCodedEvent(CodedEvent) - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
 
removePart(String) - Method in class fr.cnes.sirius.patrius.assembly.Assembly
Removes a part from the assembly.
removePart(String) - Method in class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
This method removes one part from the assembly.
removePhenomenon(Phenomenon) - Method in class fr.cnes.sirius.patrius.events.postprocessing.Timeline
 
removeProvider(Class<? extends DataProvider>) - Method in class org.orekit.data.DataProvidersManager
Deprecated. as of 6.0, replaced by DataProvidersManager.removeProvider(DataProvider)
removeProvider(DataProvider) - Method in class org.orekit.data.DataProvidersManager
Remove one provider.
removeTransformer(Class<?>) - Method in class org.apache.commons.math3.util.TransformerMap
Removes a Class to Transformer Mapping in the Map.
replaceMostRecentValue(double) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Replaces the most recently stored value with the given value.
replaceWorstPoint(PointValuePair, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Replace the worst point of the simplex by a new point.
replaceWorstPoint(PointValuePair, Comparator<PointValuePair>) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Replace the worst point of the simplex by a new point.
REPLAY_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Replay data from valuesFilePath.
Report - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
- Production of a report and log files
Report(Setup, ComparisonData, ComparisonData, ThresholdsData, URI, URI, URI, URI, URI) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.Report
Constructor.
Report - Class in fr.cnes.sirius.patrius.tools.force.validation
Class to create the simulation report.
representableDelta(double, double) - Static method in class org.apache.commons.math3.util.Precision
Computes a number delta close to originalDelta with the property that
requiresDenseOutput() - Method in class org.orekit.propagation.sampling.OrekitStepNormalizer
Determines whether this handler needs dense output.
rescale(double) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
Rescale the instance.
reSeed(long) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Reseeds the random number generator used by EmpiricalDistribution.getNextValue().
reSeed(long) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Reseeds the random number generator with the supplied seed.
reSeed() - Method in class org.apache.commons.math3.random.RandomDataGenerator
Reseeds the random number generator with System.currentTimeMillis() + System.identityHashCode(this)).
reSeed(long) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Reseeds the random number generator with the supplied seed.
reSeed() - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Reseeds the random number generator with System.currentTimeMillis() + System.identityHashCode(this)).
reSeed(long) - Method in class org.apache.commons.math3.random.ValueServer
Reseeds the random data generator.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Reseed the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
Reseeds the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Reseed the random generator used to generate samples.
reseedRandomGenerator(long) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Reseed the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Reseeds the random generator used to generate samples.
reseedRandomGenerator(long) - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Reseeds the random generator used to generate samples.
reseedRandomGenerator(long) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Reseed the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Reseed the random generator used to generate samples.
reSeedSecure() - Method in class org.apache.commons.math3.random.RandomDataGenerator
Reseeds the secure random number generator with the current time in milliseconds.
reSeedSecure(long) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Reseeds the secure random number generator with the supplied seed.
reSeedSecure() - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Reseeds the secure random number generator with the current time in milliseconds.
reSeedSecure(long) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Reseeds the secure random number generator with the supplied seed.
reset() - Method in interface fr.cnes.sirius.validate.parallel.ParallelTaskFactory
Reset method, if the factory maintains a state for the tasks.
reset(Vector3D, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Reset the instance as if built from two points.
reset(Vector3D, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Reset the instance as if built from a point and a normal.
reset(Plane) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Reset the instance from another one.
reset(Vector2D, Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Reset the instance as if built from two points.
reset(Vector2D, double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Reset the instance as if built from a line and an angle.
reset(double, double[]) - Method in class org.apache.commons.math3.ode.events.EventState
Let the event handler reset the state if it wants.
reset(SpacecraftState) - Method in class org.orekit.propagation.events.EventState
Let the event detector reset the state if it wants.
resetActiveProvider(AttitudeLaw) - Method in class org.orekit.attitudes.AttitudesSequence
Reset the active provider.
resetCount() - Method in class org.apache.commons.math3.util.Incrementor
Resets the counter to 0.
resetFitting(AbsoluteDate, double...) - Method in class org.orekit.utils.SecularAndHarmonic
Reset fitting.
resetInitialState(SpacecraftState) - Method in class fr.cnes.sirius.patrius.propagation.precomputed.multi.MultiIntegratedEphemeris
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.AbstractPropagator
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.analytical.AbstractLyddanePropagator
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.analytical.AdapterPropagator
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.analytical.J2SecularPropagator
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.analytical.KeplerianPropagator
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.precomputed.Ephemeris
Try (and fail) to reset the initial state.
resetInitialState(SpacecraftState) - Method in class org.orekit.propagation.precomputed.IntegratedEphemeris
Reset the propagator initial state.
resetInitialState(SpacecraftState) - Method in interface org.orekit.propagation.Propagator
Reset the propagator initial state.
resetInternalState() - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Reset internal state to dummy values.
resetIterationCount() - Method in class org.apache.commons.math3.util.IterationManager
Sets the iteration count to 0.
resetOccurred - Variable in class org.apache.commons.math3.ode.AbstractIntegrator
Indicator that a state or derivative reset was triggered by some event.
resetProperty() - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Resets the sensor property features.
resetReplayFile() - Method in class org.apache.commons.math3.random.ValueServer
Resets REPLAY_MODE file pointer to the beginning of the valuesFileURL.
resetState(SpacecraftState) - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
resetState(double, double[]) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMonoEventDetector
 
resetState(double, double[]) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMultiEventDetector
 
resetState(double, double[]) - Method in interface org.apache.commons.math3.ode.events.EventHandler
Reset the state prior to continue the integration.
resetState(SpacecraftState) - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
Reset the state (including additional states) prior to continue propagation.
resetState(SpacecraftState) - Method in class org.orekit.propagation.events.AbstractDetector
Reset the state (including additional states) prior to continue propagation.
resetState(double, double[]) - Method in class org.orekit.propagation.events.AdaptedEventDetector
Reset the state prior to continue the integration.
resetState(SpacecraftState) - Method in interface org.orekit.propagation.events.EventDetector
Reset the state (including additional states) prior to continue propagation.
resetState(SpacecraftState) - Method in class org.orekit.propagation.events.NthOccurrenceDetector
Reset the state (including additional states) prior to continue propagation.
resetState(SpacecraftState) - Method in class org.orekit.propagation.events.NullMassPartDetector
Reset the state (including additional states) prior to continue propagation.
resetStates(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
resetStates(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
 
resetStates(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
 
resetStates(Map<String, SpacecraftState>) - Method in class fr.cnes.sirius.patrius.propagation.events.multi.OneSatEventDetectorWrapper
 
resetStates(Map<String, SpacecraftState>) - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
 
resetStates(Map<String, SpacecraftState>) - Method in interface org.orekit.propagation.events.multi.MultiEventDetector
Reset the states (including additional states) prior to continue propagation.
resetStates(Map<String, SpacecraftState>) - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
 
resetTransform() - Static method in class fr.cnes.sirius.patrius.stela.bodies.MeeusMoonStela
Reset cached transform.
resetTransform() - Static method in class fr.cnes.sirius.patrius.stela.bodies.MeeusSunStela
Reset cached transform.
ResizableDoubleArray - Class in org.apache.commons.math3.util
A variable length DoubleArray implementation that automatically handles expanding and contracting its internal storage array as elements are added and removed.
ResizableDoubleArray() - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with default properties.
ResizableDoubleArray(int) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with the specified initial capacity.
ResizableDoubleArray(double[]) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance from an existing double[] with the initial capacity and numElements corresponding to the size of the supplied double[] array.
ResizableDoubleArray(int, float) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Please use ResizableDoubleArray.ResizableDoubleArray(int,double) instead.
ResizableDoubleArray(int, double) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with the specified initial capacity and expansion factor.
ResizableDoubleArray(int, float, float) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Please use ResizableDoubleArray.ResizableDoubleArray(int,double,double) instead.
ResizableDoubleArray(int, double, double) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with the specified initial capacity, expansion factor, and contraction criteria.
ResizableDoubleArray(int, float, float, int) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Please use ResizableDoubleArray.ResizableDoubleArray(int,double,double,ExpansionMode,double[]) instead.
ResizableDoubleArray(int, double, double, ResizableDoubleArray.ExpansionMode, double...) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Creates an instance with the specified properties.
ResizableDoubleArray(ResizableDoubleArray) - Constructor for class org.apache.commons.math3.util.ResizableDoubleArray
Copy constructor.
ResizableDoubleArray.ExpansionMode - Enum in org.apache.commons.math3.util
Specification of expansion algorithm.
resizeThreadPool(int) - Method in class fr.cnes.sirius.validate.parallel.ParallelRunner
Resizes the thread pool.
restrictToNonNegative() - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated.  
resultEquals(ParallelResult) - Method in interface fr.cnes.sirius.validate.parallel.ParallelResult
Equals-like method for ParallelResult instances.
ResultsFileWriter - Class in fr.cnes.sirius.validate.files
This class offers different functions to write results in output files for different purposes : plot a 2D graphics under excel or scilab using VTS visualization tool
returnAssembly() - Method in class fr.cnes.sirius.patrius.assembly.AssemblyBuilder
This method returns the assembly when the user wants to get the instance of the assembly that has been built so far.
reunite(SubHyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Compute the union of the instance and another sub-hyperplane.
reunite(SubHyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Compute the union of the instance and another sub-hyperplane.
revert() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Revert a rotation.
revert() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Get a line with reversed direction.
revert() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Revert a rotation.
revert(boolean) - Method in class org.orekit.utils.AngularCoordinates
Revert a rotation/rotation rate/rotation acceleration triplet.
revert() - Method in class org.orekit.utils.AngularCoordinates
Revert a rotation/rotation rate/rotation acceleration triplet.
revert(boolean) - Method in class org.orekit.utils.TimeStampedAngularCoordinates
Revert a rotation/rotation rate/rotation acceleration triplet.
revert() - Method in class org.orekit.utils.TimeStampedAngularCoordinates
Revert a rotation/rotation rate/rotation acceleration triplet.
revertSelf() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Revert the instance.
revertSelf() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Revert the plane.
revertSelf() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Revert the instance.
RFAntennaProperty - Class in fr.cnes.sirius.patrius.assembly.properties
This class represents an RF antenna property for a part of the assembly.
RFAntennaProperty(double, double[], double[], double[][], double[][], double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.assembly.properties.RFAntennaProperty
Constructor of this property.
RFLinkBudgetModel - Class in fr.cnes.sirius.patrius.assembly.models
This class contains the algorithm to compute the link budget knowing the satellite transmitter and ground receiver parameters.
The link budget is the accounting of all of the gains and losses from the transmitter (the satellite), through the medium to the receiver (the ground station).
RFLinkBudgetModel(RFStationAntenna, Assembly, String) - Constructor for class fr.cnes.sirius.patrius.assembly.models.RFLinkBudgetModel
Constructor for the link budget model.
RFStationAntenna - Class in fr.cnes.sirius.patrius.groundstation
This class represents an RF antenna model for a ground station.
RFStationAntenna(TopocentricFrame, double, double, double, double[][], double[][], double) - Constructor for class fr.cnes.sirius.patrius.groundstation.RFStationAntenna
Constructor of the station antenna model.
RFVisibilityDetector - Class in fr.cnes.sirius.patrius.events.sensor
Finder for ground station / satellite RF visibility events.
RFVisibilityDetector(RFLinkBudgetModel, double, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.RFVisibilityDetector
Constructor for the sensor masking detector.
RFVisibilityDetector(RFLinkBudgetModel, double, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.RFVisibilityDetector
Constructor for the sensor masking detector.
RFVisibilityDetector(RFLinkBudgetModel, double, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.RFVisibilityDetector
Constructor for the sensor masking detector.
RHO - Static variable in class org.orekit.forces.gravity.tides.OceanTides
Parameter name for Density at surface.
RiddersDifferentiator - Class in org.apache.commons.math3.analysis.differentiation
Implements Ridders method of polynomial extrapolation for differentiation of real univariate functions.
The algorithm implemented in this class comes from Numerical Recipes in Fortran 77 : the art of scientific computing.
With respect to the UnivariateDifferentiableFunction implementation, since this class uses a specific differentiation algorithm, the returned DerivativeStructure instances are constant ( they cannot provide derivatives other than the first order already computed when they are created).
RiddersDifferentiator(double) - Constructor for class org.apache.commons.math3.analysis.differentiation.RiddersDifferentiator
Constructor.
RiddersSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Ridders' Method for root finding of real univariate functions.
RiddersSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.RiddersSolver
Construct a solver with default accuracy (1e-6).
RiddersSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.RiddersSolver
Construct a solver.
RiddersSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.RiddersSolver
Construct a solver.
RightCircularCone - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D right circular cone ended by a plane normal to its axis, with some algorithm to compute intersections and distances to some other objects.
RightCircularCone(Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
Build a elliptic cone from its radius, the height, the origin (apex) and direction of its axis
RightCircularCylinder - Class in org.apache.commons.math3.geometry.euclidean.threed
This is a describing class for a 3D right circular cylinder ended by two planes normal to its axis, with some algorithm to compute intersections and distances to some other objects.
RightCircularCylinder(Line, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
Build an infinite right circular cylinder from its radius and its axis as a line
RightCircularCylinder(Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
Build an infinite right circular cylinder from its radius and the origin and direction of its axis
rint() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
Rint - Class in org.apache.commons.math3.analysis.function
rint function.
Rint() - Constructor for class org.apache.commons.math3.analysis.function.Rint
 
rint() - Method in class org.apache.commons.math3.dfp.Dfp
Round to nearest integer using the round-half-even method.
rint() - Method in interface org.apache.commons.math3.RealFieldElement
Get the whole number that is the nearest to the instance, or the even one if x is exactly half way between two integers.
rint(double) - Static method in class org.apache.commons.math3.util.FastMath
Get the whole number that is the nearest to x, or the even one if x is exactly half way between two integers.
ROLL_OVER_WEEK_GALILEO - Static variable in class fr.cnes.sirius.patrius.utils.GalileoAlmanacParameters
Roll-over week number for Galileo parameters.
ROLL_OVER_WEEK_GPS - Static variable in class fr.cnes.sirius.patrius.utils.GPSAlmanacParameters
Roll-over week number for GPS parameters.
ROMBERG_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.RombergIntegrator
Maximal number of iterations for Romberg.
RombergIntegrator - Class in org.apache.commons.math3.analysis.integration
Implements the Romberg Algorithm for integration of real univariate functions.
RombergIntegrator(double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.RombergIntegrator
Build a Romberg integrator with given accuracies and iterations counts.
RombergIntegrator(int, int) - Constructor for class org.apache.commons.math3.analysis.integration.RombergIntegrator
Build a Romberg integrator with given iteration counts.
RombergIntegrator() - Constructor for class org.apache.commons.math3.analysis.integration.RombergIntegrator
Construct a Romberg integrator with default settings (max iteration count set to RombergIntegrator.ROMBERG_MAX_ITERATIONS_COUNT)
rootLogLikelihoodRatio(long, long, long, long) - Method in class org.apache.commons.math3.stat.inference.GTest
Calculates the root log-likelihood ratio for 2 state Datasets.
rootLogLikelihoodRatio(long, long, long, long) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
rootN(int) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Nth root.
rootN(double[], int, int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute nth root of a derivative structure.
rootN(int) - Method in interface org.apache.commons.math3.RealFieldElement
Nth root.
rootsFiltering(Complex[]) - Method in class fr.cnes.sirius.patrius.stela.forces.radiation.SRPSquaring
Filtering of computed roots.
RootsOfUnity - Class in org.apache.commons.math3.complex
A helper class for the computation and caching of the n-th roots of unity.
RootsOfUnity() - Constructor for class org.apache.commons.math3.complex.RootsOfUnity
Build an engine for computing the n-th roots of unity.
rotate(Vector3D, Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Rotate the plane around the specified point.
rotate(Vector3D, Rotation) - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Rotate the region around the specified point.
Rotation - Class in org.apache.commons.math3.geometry.euclidean.threed
This class implements rotations in a three-dimensional space.
Rotation(boolean, double, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from the quaternion coordinates.
Rotation(boolean, Quaternion) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from the quaternion.
Rotation(boolean, double[]) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from the quaternion coordinates.
Rotation(Vector3D, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from an axis and an angle.
Rotation(double[][], double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from a 3X3 matrix.
Rotation(Vector3D, Vector3D, Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build the rotation that transforms a pair of vector into another pair.
Rotation(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build one of the rotations that transform one vector into another one.
Rotation(RotationOrder, double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Build a rotation from three Cardan or Euler elementary rotations.
RotationDPFacade - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class is a facade for the use of dates.
RotationDPFacade(double) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.RotationDPFacade
Constructor from an angle.
RotationDPFacade(Double, Double, Double) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.RotationDPFacade
Build a rotation from Cardan angles.
RotationDPFacade(double, double, double, double) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.RotationDPFacade
Constructor from an axis and an angle.
RotationDPFacade(double[][]) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.RotationDPFacade
Constructor from a matrix.
rotationFromInertial(PVCoordinates) - Method in enum org.orekit.frames.LOFType
Get the rotation from inertial frame to local orbital frame.
RotationInterpolator - Interface in org.orekit.attitudes.kinematics
Deprecated. since 3.1 use instead Attitude.interpolate(AbsoluteDate, Collection) or Attitude.slerp(AbsoluteDate, Attitude, Attitude, Frame, boolean)
RotationOrder - Class in org.apache.commons.math3.geometry.euclidean.threed
This class is a utility representing a rotation order specification for Cardan or Euler angles specification.
round() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Get the closest long to instance value.
round(int) - Method in class org.apache.commons.math3.dfp.Dfp
Round this given the next digit n using the current rounding mode.
round(int) - Method in class org.apache.commons.math3.dfp.DfpDec
Round this given the next digit n using the current rounding mode.
round() - Method in interface org.apache.commons.math3.RealFieldElement
Get the closest long to instance value.
round(double) - Static method in class org.apache.commons.math3.util.FastMath
Get the closest long to x.
round(float) - Static method in class org.apache.commons.math3.util.FastMath
Get the closest int to x.
round(double, int) - Static method in class org.apache.commons.math3.util.Precision
Rounds the given value to the specified number of decimal places.
round(double, int, int) - Static method in class org.apache.commons.math3.util.Precision
Rounds the given value to the specified number of decimal places.
round(float, int) - Static method in class org.apache.commons.math3.util.Precision
Rounds the given value to the specified number of decimal places.
round(float, int, int) - Static method in class org.apache.commons.math3.util.Precision
Rounds the given value to the specified number of decimal places.
rows - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1.
runAll() - Method in class fr.cnes.sirius.validate.parallel.ParallelRunner
Run all the tasks.
runEXTENDEDPRECISION(int) - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
runEXTENDEDPRECISION
runFIXEDPRECISION(int) - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
runFIXEDPRECISION.
RungeKutta6Integrator - Class in org.apache.commons.math3.ode.nonstiff
A 6th order Runge-Kutta Integrators
RungeKutta6Integrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.RungeKutta6Integrator
Simple constructor.
RungeKutta6StepInterpolator - Class in org.apache.commons.math3.ode.nonstiff
Interpolator for RungeKutta6Integrator.
RungeKutta6StepInterpolator() - Constructor for class org.apache.commons.math3.ode.nonstiff.RungeKutta6StepInterpolator
Simple constructor.
RungeKutta6StepInterpolator(RungeKutta6StepInterpolator) - Constructor for class org.apache.commons.math3.ode.nonstiff.RungeKutta6StepInterpolator
Copy constructor.
RungeKuttaIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the common part of all fixed step Runge-Kutta integrators for Ordinary Differential Equations.
RungeKuttaIntegrator(String, double[], double[][], double[], RungeKuttaStepInterpolator, double) - Constructor for class org.apache.commons.math3.ode.nonstiff.RungeKuttaIntegrator
Simple constructor.
runNOCHANGE() - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
runNOCHANGE.
runSTOCHASTIC() - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
runSTOCHASTIC
runSTRICTMATH() - Method in class fr.cnes.sirius.validate.jqnum.JQNUMTools
runSTRICTMATH.

S

S - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroGlobalProperty
Default surface parameter name.
s4 - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
s* new value for the contant s.
SaastamoinenModel - Class in org.orekit.models.earth
The modified Saastamoinen model.
SaastamoinenModel(double, double, double) - Constructor for class org.orekit.models.earth.SaastamoinenModel
Create a new Saastamoinen model for the troposphere using the given environmental conditions.
SAFE_MIN - Static variable in class org.apache.commons.math3.util.Precision
Safe minimum, such that 1 / SAFE_MIN does not overflow.
SAFE_MIN - Static variable in class org.apache.commons.math3.UtilsCommonsMath
Safe minimum, such that 1 / SAFE_MIN does not overflow.
safeNorm(double[]) - Static method in class org.apache.commons.math3.util.MathArrays
Returns the Cartesian norm (2-norm), handling both overflow and underflow.
SAM - Static variable in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00Data
SEMIANNUAL MULT SAM
sameOrientationAs(Hyperplane<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Check if the instance has the same orientation as another hyperplane.
sameOrientationAs(Hyperplane<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Check if the instance has the same orientation as another hyperplane.
sameOrientationAs(Hyperplane<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Check if the instance has the same orientation as another hyperplane.
sameOrientationAs(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Check if the instance has the same orientation as another hyperplane.
sample(UnivariateFunction, double, double, int) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Samples the specified univariate real function on the specified interval.
sample() - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Generate a random value sampled from this distribution.
sample(int) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
Generate a random sample from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
Generates a random value vector sampled from this distribution.
sample(int) - Method in class org.apache.commons.math3.distribution.AbstractMultivariateRealDistribution
Generates a list of a random value vectors from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Generate a random value sampled from this distribution.
sample(int) - Method in class org.apache.commons.math3.distribution.AbstractRealDistribution
Generate a random sample from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.ExponentialDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.GammaDistribution
This implementation uses the following algorithms:
sample() - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Generate a random value sampled from this distribution.
sample(int) - Method in interface org.apache.commons.math3.distribution.IntegerDistribution
Generate a random sample from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.LogNormalDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.MixtureMultivariateRealDistribution
Generates a random value vector sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.MultivariateNormalDistribution
Generates a random value vector sampled from this distribution.
sample() - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Generates a random value vector sampled from this distribution.
sample(int) - Method in interface org.apache.commons.math3.distribution.MultivariateRealDistribution
Generates a list of a random value vectors from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.NormalDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.PoissonDistribution
Generate a random value sampled from this distribution.
sample() - Method in interface org.apache.commons.math3.distribution.RealDistribution
Generate a random value sampled from this distribution.
sample(int) - Method in interface org.apache.commons.math3.distribution.RealDistribution
Generate a random sample from the distribution.
sample() - Method in class org.apache.commons.math3.distribution.UniformIntegerDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.distribution.UniformRealDistribution
Generate a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math3.random.EmpiricalDistribution
Generate a random value sampled from this distribution.
sanityChecks(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Check the integration span.
sanityChecks(ExpandableStatefulODE, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Check the integration span.
SatelliteInformation - Class in org.orekit.files.general
Contains general information about a satellite as contained in an orbit file.
SatelliteInformation(String) - Constructor for class org.orekit.files.general.SatelliteInformation
Create a new SatelliteInformation object with a given satellite id.
SatelliteTimeCoordinate - Class in org.orekit.files.general
Contains the position/velocity of a satellite at an specific epoch.
SatelliteTimeCoordinate(AbsoluteDate, PVCoordinates) - Constructor for class org.orekit.files.general.SatelliteTimeCoordinate
Creates a new SatelliteTimeCoordinate instance with a given epoch and coordinate.
SatelliteTimeCoordinate(AbsoluteDate, Vector3D, double) - Constructor for class org.orekit.files.general.SatelliteTimeCoordinate
Creates a new SatelliteTimeCoordinate object with a given epoch and position coordinate.
SatelliteTimeCoordinate(AbsoluteDate, PVCoordinates, double, double) - Constructor for class org.orekit.files.general.SatelliteTimeCoordinate
Creates a new SatelliteTimeCoordinate instance with a given epoch, coordinate and clock value / rate change.
SatToSatMutualVisibilityDetector - Class in fr.cnes.sirius.patrius.events.sensor
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.sensor.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.sensor.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.sensor.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.sensor.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.sensor.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.sensor.SatToSatMutualVisibilityDetector
Constructor to be used for multi-spacecraft propagation only ( MultiPropagator).
SATURN - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Saturn.
scalAbsoluteTolerance - Variable in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Allowed absolute scalar error.
scalarAdd(double) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Add a scalar
scalarAdd(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Add a scalar
scalarAdd(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Add a scalar to a TrigonometricPolynomialPrimitive
scalarAdd(T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Increment each entry of this matrix.
scalarAdd(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of adding d to each entry of this.
scalarAdd(T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Increment each entry of this matrix.
scalarAdd(double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of adding d to each entry of this.
scalarAdd(T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Increment each entry of this matrix.
scalarAdd(double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of adding d to each entry of this.
scalarDivide(double) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Divide by a scalar
scalarDivide(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Divide by a scalar
scalarDivide(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Divide by a scalar
scalarMultiply(double, double[][]) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Return coef * matrix.
scalarMultiply(double) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Multiply by a scalar
scalarMultiply(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Multiply by a scalar
scalarMultiply(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Multiply TrigonometricPolynomialPrimitive by a scalar
scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Multiply the instance by a scalar.
scalarMultiply(T) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiply the instance by a scalar.
scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Multiply the instance by a scalar.
scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Multiply the instance by a scalar.
scalarMultiply(double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Multiply the instance by a scalar.
scalarMultiply(double) - Method in interface org.apache.commons.math3.geometry.Vector
Multiply the instance by a scalar.
scalarMultiply(T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Multiply each entry by d.
scalarMultiply(double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the result of multiplying each entry of this by d.
scalarMultiply(T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Multiply each entry by d.
scalarMultiply(double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the result of multiplying each entry of this by d.
scalarMultiply(T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Multiply each entry by d.
scalarMultiply(double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the result of multiplying each entry of this by d.
scalarMultiply(double) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns the result of multiplying each entry of this by d.
scalarSubtract(double) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Subtract a scalar
scalarSubtract(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Subtract a scalar
scalarSubtract(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Subtract a scalar
scalb(int) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Multiply the instance by a power of 2.
scalb(int) - Method in interface org.apache.commons.math3.RealFieldElement
Multiply the instance by a power of 2.
scalb(double, int) - Static method in class org.apache.commons.math3.util.FastMath
Multiply a double number by a power of 2.
scalb(float, int) - Static method in class org.apache.commons.math3.util.FastMath
Multiply a float number by a power of 2.
scaleArray(double[], double) - Static method in class org.apache.commons.math3.transform.TransformUtils
Multiply every component in the given real array by the given real number.
scaleArray(Complex[], double) - Static method in class org.apache.commons.math3.transform.TransformUtils
Multiply every component in the given complex array by the given real number.
scaled - Variable in class org.apache.commons.math3.ode.MultistepIntegrator
First scaled derivative (h y').
scalRelativeTolerance - Variable in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Allowed relative scalar error.
SchwarzschildRelativisticEffect - Class in org.orekit.forces.relativistic
Computation of the relativistic Schwarzschild effect.
SchwarzschildRelativisticEffect(double, boolean, boolean) - Constructor for class org.orekit.forces.relativistic.SchwarzschildRelativisticEffect
Constructor.
SchwarzschildRelativisticEffect(double) - Constructor for class org.orekit.forces.relativistic.SchwarzschildRelativisticEffect
Constructor with partial derivative computation by default.
Screw - Class in org.apache.commons.math3.geometry.euclidean.threed
This class represents a screw
Screw(Screw) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Screw
Build a copy of a screw.
Screw(Vector3D, Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Screw
Constructor
SDP4 - Static variable in class org.orekit.propagation.analytical.tle.TLE
Identifier for SDP4 type of ephemeris.
SDP8 - Static variable in class org.orekit.propagation.analytical.tle.TLE
Identifier for SDP8 type of ephemeris.
search(UnivariateFunction, GoalType, double, double) - Method in class org.apache.commons.math3.optim.univariate.BracketFinder
Search new points that bracket a local optimum of the function.
search(UnivariateFunction, GoalType, double, double) - Method in class org.apache.commons.math3.optimization.univariate.BracketFinder
Deprecated. Search new points that bracket a local optimum of the function.
searchForFitnessUpdate(Population) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.utils
Index search algorithms based on method BinarySearch, coupled with dichotomy.
Contains two algorithms for both intervals conventions defined by ISearchIndex.SearchIndexIntervalConvention.
Also contains utility functions.
SearchInterval - Class in org.apache.commons.math3.optim.univariate
Search interval and (optional) start value.
SearchInterval(double, double, double) - Constructor for class org.apache.commons.math3.optim.univariate.SearchInterval
 
SearchInterval(double, double) - Constructor for class org.apache.commons.math3.optim.univariate.SearchInterval
 
searchXIndex - Variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
xtab used for search and satisfies condition from SearchIndex.
searchYIndex - Variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
ytab used for search and satisfies condition from SearchIndex.
searchZIndex - Variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
ztab used for search and satisfies condition from SearchIndex.
SecantSolver - Class in org.apache.commons.math3.analysis.solvers
Implements the Secant method for root-finding (approximating a zero of a univariate real function).
SecantSolver() - Constructor for class org.apache.commons.math3.analysis.solvers.SecantSolver
Construct a solver with default accuracy (1e-6).
SecantSolver(double) - Constructor for class org.apache.commons.math3.analysis.solvers.SecantSolver
Construct a solver.
SecantSolver(double, double) - Constructor for class org.apache.commons.math3.analysis.solvers.SecantSolver
Construct a solver.
SecondaryEquations - Interface in org.apache.commons.math3.ode
This interface allows users to add secondary differential equations to a primary set of differential equations.
SecondarySpacecraft - Class in fr.cnes.sirius.patrius.events.sensor
Secondary spacecraft to be used in events detections.
SecondarySpacecraft(Assembly, Propagator, String) - Constructor for class fr.cnes.sirius.patrius.events.sensor.SecondarySpacecraft
Constructor for a secondary spacecraft to be used in events detections.
SecondMoment - Class in org.apache.commons.math3.stat.descriptive.moment
Computes a statistic related to the Second Central Moment.
SecondMoment() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Create a SecondMoment instance
SecondMoment(SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SecondMoment
Copy constructor, creates a new SecondMoment identical to the original
SecondOrderDifferentialEquations - Interface in org.apache.commons.math3.ode
This interface represents a second order differential equations set.
SecondOrderIntegrator - Interface in org.apache.commons.math3.ode
This interface represents a second order integrator for differential equations.
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 org.orekit.utils
Class for fitting evolution of osculating orbital parameters.
SecularAndHarmonic(int, double...) - Constructor for class org.orekit.utils.SecularAndHarmonic
Simple constructor.
secularOrbitIn - Variable in class org.orekit.propagation.analytical.AbstractLyddanePropagator
Secular orbit.
Segment - Class in org.apache.commons.math3.geometry.euclidean.threed
Simple container for a two-points segment.
Segment(Vector3D, Vector3D, Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Segment
Build a segment.
Segment - Class in org.apache.commons.math3.geometry.euclidean.twod
Simple container for a two-points segment.
Segment(Vector2D, Vector2D, Line) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Segment
Build a segment.
SEIDELMANN_UA - Static variable in interface org.orekit.utils.CnesConstants
UA from the 1992 Astronomical Almanac by P.
select(Population) - Method in interface org.apache.commons.math3.genetics.SelectionPolicy
Select two chromosomes from the population.
select(Population) - Method in class org.apache.commons.math3.genetics.TournamentSelection
Select two chromosomes from the population.
selectExtrapolator(TLE) - Static method in class org.orekit.propagation.analytical.tle.TLEPropagator
Selects the extrapolator to use with the selected TLE.
selectExtrapolator(TLE, AttitudeProvider, MassProvider) - Static method in class org.orekit.propagation.analytical.tle.TLEPropagator
Selects the extrapolator to use with the selected TLE.
selectExtrapolator(TLE, AttitudeProvider, AttitudeProvider, MassProvider) - Static method in class org.orekit.propagation.analytical.tle.TLEPropagator
Selects the extrapolator to use with the selected TLE.
SelectionPolicy - Interface in org.apache.commons.math3.genetics
Algorithm used to select a chromosome pair from a population.
selectParamAndStep(Parameter, double) - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Select the parameters to consider for Jacobian processing.
selectParameters(Parameter...) - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Select the parameters to consider for Jacobian processing.
SemiVariance - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the semivariance of a set of values with respect to a given cutoff value.
SemiVariance() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with default (true) biasCorrected property and default (Downside) varianceDirection property.
SemiVariance(boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with the specified biasCorrected property and default (Downside) varianceDirection property.
SemiVariance(SemiVariance.Direction) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with the specified Direction property and default (true) biasCorrected property
SemiVariance(boolean, SemiVariance.Direction) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with the specified isBiasCorrected property and the specified Direction property.
SemiVariance(SemiVariance) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Copy constructor, creates a new SemiVariance identical to the original
SemiVariance.Direction - Enum in org.apache.commons.math3.stat.descriptive.moment
The direction of the semivariance - either upside or downside.
SensorInhibitionDetector - Class in fr.cnes.sirius.patrius.events.sensor
 
SensorInhibitionDetector(Assembly, String, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.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.sensor.SensorInhibitionDetector
Constructor for the "inhibition" detector
SensorInhibitionDetector(SensorModel, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.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.sensor.SensorInhibitionDetector
Constructor for the "inhibition" detector
SensorInhibitionDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.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.sensor
 
SensorVisibilityDetector(Assembly, String, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.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.sensor.SensorVisibilityDetector
Constructor for the "visibility view" detector
SensorVisibilityDetector(SensorModel, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.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.sensor.SensorVisibilityDetector
Constructor for the "visibility" detector
SensorVisibilityDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
Constructor for the "visibility" detector
sequence(int, int, int) - Static method in class org.apache.commons.math3.util.MathArrays
Returns an array of size integers starting at start, skipping stride numbers.
sequence - Variable in class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
Attitude legs sequence.
serializeRealMatrix(RealMatrix, ObjectOutputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Serialize a RealMatrix.
serializeRealVector(RealVector, ObjectOutputStream) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Serialize a RealVector.
SeriesTerm - Class in org.orekit.data
Base class for nutation series terms.
SeriesTerm(double, double) - Constructor for class org.orekit.data.SeriesTerm
Simple constructor for the base class.
set(int, ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Set a set of consecutive elements.
set(T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Set all elements to a single value.
set(double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Set all elements to a single value.
set(T) - Method in interface org.apache.commons.math3.linear.FieldVector
Set all elements to a single value.
set(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Set all elements to a single value.
set(double) - Method in class org.apache.commons.math3.linear.RealVector
Set all elements to a single value.
set(T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Set all elements to a single value.
set2ndConvergenceThreshold(double) - Method in class org.orekit.bodies.OneAxisEllipsoid
Set the 2nd convergence threshold.
setAccuracy(int) - Method in class org.orekit.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 org.orekit.propagation.numerical.NumericalPropagator
Add additional state tolerances.
setAe(double) - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
 
setAgency(String) - Method in class org.orekit.files.sp3.SP3File
Set the agency string for this SP3 file.
setAlbedoAcc(boolean) - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
albedo setter
setAlt(double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for alt.
setAngle(double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Set the angle of the line.
setAngularThreshold(double) - Method in class org.orekit.bodies.OneAxisEllipsoid
Set the angular convergence threshold.
setAp(double[]) - Method in class org.orekit.forces.atmospheres.MSIS2000.ApCoef
Setter for AP.
setAp(int, int) - Method in class org.orekit.forces.atmospheres.MSIS2000.ApCoef
Setter for a specific element of the AP array.
setAp(double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for ap.
setApA(ApCoef) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for apA.
setApA(double[]) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for apA.
setArity(int) - Method in class org.apache.commons.math3.genetics.TournamentSelection
Sets the arity (number of chromosomes drawn to the tournament).
setAttitudeLaw(AttitudeProvider) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Deprecated. as of 6.0 replaced by NumericalPropagator.setAttitudeProvider(AttitudeProvider)
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
 
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.
setAttitudeProvider(AttitudeProvider) - Method in class org.orekit.propagation.AbstractPropagator
Set attitude provider for forces and events computation.
setAttitudeProvider(AttitudeProvider) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set attitude provider for forces and events computation.
setAttitudeProvider(AttitudeProvider) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
 
setAttitudeProvider(AttitudeProvider) - Method in interface org.orekit.propagation.Propagator
Set attitude provider for forces and 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
 
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.
setAttitudeProviderEvents(AttitudeProvider) - Method in class org.orekit.propagation.AbstractPropagator
Set attitude provider for events computation.
setAttitudeProviderEvents(AttitudeProvider) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set attitude provider for events computation.
setAttitudeProviderEvents(AttitudeProvider) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
 
setAttitudeProviderEvents(AttitudeProvider) - Method in interface org.orekit.propagation.Propagator
Set attitude provider for events 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
 
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.
setAttitudeProviderForces(AttitudeProvider) - Method in class org.orekit.propagation.AbstractPropagator
Set attitude provider for forces computation.
setAttitudeProviderForces(AttitudeProvider) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set attitude provider for forces computation.
setAttitudeProviderForces(AttitudeProvider) - Method in class org.orekit.propagation.precomputed.AbstractEphemeris
 
setAttitudeProviderForces(AttitudeProvider) - Method in interface org.orekit.propagation.Propagator
Set attitude provider for forces computation.
setAttribute(Object) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Associate an attribute with the instance.
setBarycenter(Vector<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Set the barycenter of the instance.
setBiasCorrected(boolean) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Sets the biasCorrected property.
setBiasCorrected(boolean) - Method in class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
 
setBiasCorrected(boolean) - Method in class org.apache.commons.math3.stat.descriptive.moment.Variance
 
setCacheSlotsNumber(int) - Static method in class org.orekit.utils.OrekitConfiguration
Set the number of slots to use in caches.
setChromosomes(List<Chromosome>) - Method in class org.apache.commons.math3.genetics.ListPopulation
Deprecated. use ListPopulation.addChromosomes(Collection) instead
setClockCorrection(double) - Method in class org.orekit.files.general.SatelliteTimeCoordinate
Set the clock correction to the given value.
setClockRateChange(double) - Method in class org.orekit.files.general.SatelliteTimeCoordinate
Set the clock rate change to the given value.
setCloseApproachThreshold(double) - Method in class org.orekit.bodies.OneAxisEllipsoid
Set the close approach threshold.
setColumn(int, T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in column number column as a column matrix.
setColumn(int, double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified column of this matrix to the entries of the specified array.
setColumn(int, T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in column number column as a column matrix.
setColumn(int, double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified column of this matrix to the entries of the specified array.
setColumn(int, T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in column number column as a column matrix.
setColumn(int, double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified column of this matrix to the entries of the specified array.
setColumnMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in column number column as a column matrix.
setColumnMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified column of this matrix to the entries of the specified column matrix.
setColumnMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in column number column as a column matrix.
setColumnMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified column of this matrix to the entries of the specified column matrix.
setColumnMatrix(int, FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in column number column as a column matrix.
setColumnMatrix(int, RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified column of this matrix to the entries of the specified column matrix.
setColumnVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in column number column as a vector.
setColumnVector(int, RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified column of this matrix to the entries of the specified vector.
setColumnVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in column number column as a vector.
setColumnVector(int, RealVector) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified column of this matrix to the entries of the specified vector.
setColumnVector(int, FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in column number column as a vector.
setColumnVector(int, RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified column of this matrix to the entries of the specified vector.
setCompleteState(double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Set the complete current state.
setConfiguration(FramesConfiguration) - Static method in class org.orekit.frames.FramesFactory
Sets a new configuration.
setContractionCriteria(float) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1 (to be removed in 4.0 as field will become "final").
setControlFactors(double, double, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Set the step size control factors.
setCoordinate(PVCoordinates) - Method in class org.orekit.files.general.SatelliteTimeCoordinate
Set the coordinate for this entry.
setCoordinateSystem(String) - Method in class org.orekit.files.sp3.SP3File
Set the coordinate system used for the orbit entries.
setCost(double) - Method in class org.apache.commons.math3.optim.nonlinear.vector.jacobian.AbstractLeastSquaresOptimizer
Sets the cost.
setCost(double) - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. Sets the cost.
setD(int, double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Output
Setter for ith density component.
setData(double[]) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Set the data array.
setData(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
Set the data array.
setData(double[]) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Set the data array.
setData(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Set the data array.
setDataUsed(String) - Method in class org.orekit.files.sp3.SP3File
Set the data used indicator for this SP3 file.
setDayFraction(double) - Method in class org.orekit.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
setDenominatorFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.AbstractFormat
Modify the denominator format.
setDiurnalRotation(DiurnalRotation) - Method in class org.orekit.frames.configuration.FramesConfigurationBuilder
Setter for diurnal rotation provider in the builder.
setDiurnalRotationModel(DiurnalRotation) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Set the diurnal rotation model.
setDoy(int) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for doy.
setElement(int, double) - Method in interface org.apache.commons.math3.util.DoubleArray
Sets the element at the specified index.
setElement(int, double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Sets the element at the specified index.
setElitismRate(double) - Method in class org.apache.commons.math3.genetics.ElitisticListPopulation
Sets the elitism rate, i.e.
setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Set the entry in the specified row and column.
setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Set the entry in the specified row and column.
setEntry(int, T) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Set a single element.
setEntry(int, double) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Set a single element.
setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Set the entry in the specified row and column.
setEntry(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entry in the specified row and column.
setEntry(int, T) - Method in interface org.apache.commons.math3.linear.FieldVector
Set a single element.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Set the entry in the specified row and column.
setEntry(int, double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Set a single element.
setEntry(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrix
Set the entry in the specified row and column.
setEntry(int, double) - Method in class org.apache.commons.math3.linear.RealVector
Set a single element.
setEntry(int, int, T) - Method in class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Set the entry in the specified row and column.
setEntry(int, T) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Set a single element.
setEntry(int, int, double) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Set the entry in the specified row and column.
setEOP2000History(EOP2000History) - Method in class org.orekit.frames.configuration.FramesConfigurationBuilder
Setter for history provider in the builder.
setEOPHistory(EOP2000History) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Set the EOP history.
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.stela.propagation.StelaAbstractPropagator
Set the propagator to ephemeris generation mode.
setEphemerisMode() - Method in class org.orekit.propagation.AbstractPropagator
Set the propagator to ephemeris generation mode.
setEphemerisMode() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set the propagator to ephemeris generation mode.
setEphemerisMode() - Method in interface org.orekit.propagation.Propagator
Set the propagator to ephemeris generation mode.
setEpoch(AbsoluteDate) - Method in class org.orekit.files.general.SatelliteTimeCoordinate
Set the epoch for this coordinate.
setEpoch(AbsoluteDate) - Method in class org.orekit.files.sp3.SP3File
Set the epoch of the SP3 file.
setEpochInterval(double) - Method in class org.orekit.files.sp3.SP3File
Set the epoch interval for this SP3 file.
setEquations(ExpandableStatefulODE) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Set the equations.
setExpansionFactor(float) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1 (to be removed in 4.0 as field will become "final").
setExpansionMode(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1. Please use ResizableDoubleArray.setExpansionMode(ExpansionMode) instead.
setExpansionMode(ResizableDoubleArray.ExpansionMode) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1 (to be removed in 4.0 as field will become "final").
setF107(double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for f107.
setF107A(double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for f107A.
setFiring(boolean) - Method in class org.orekit.forces.maneuvers.ConstantThrustError
Set maneuver status.
setFiring(boolean) - Method in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Set maneuver status.
setFiring(boolean) - Method in class org.orekit.forces.maneuvers.VariableThrustManeuver
Set maneuver status.
setFirstCovarianceMatrix(RealMatrix, AbsoluteDate) - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
Allows to change the CovarianceMatrix standing for the lower bound of the interpolation interval, associated with t1.
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 org.apache.commons.math3.analysis.polynomials.FourierDecompositionEngine
Set the UnivariateFunction to decompose and its period.
setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the geometric mean.
setGeometricMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the gemoetric mean.
setgLat(double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for gLat.
setgLong(double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for gLong.
setGpsWeek(int) - Method in class org.orekit.files.sp3.SP3File
Set the GPS week of the SP3 file.
setIEEEFlags(int) - Method in class org.apache.commons.math3.dfp.DfpField
Sets the IEEE 854 status flags.
setIEEEFlagsBits(int) - Method in class org.apache.commons.math3.dfp.DfpField
Sets some bits in the IEEE 854 status flags, without changing the already set bits.
setIndex(int) - Method in class org.apache.commons.math3.linear.RealVector.Entry
Set the index of the entry.
setInertiaMatrix(Matrix3D) - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
Sets the inertia matrix
setInertiaMatrix(Matrix3D) - Method in class fr.cnes.sirius.patrius.assembly.properties.InertiaSimpleProperty
Sets the inertia matrix at the mass center of the part.
setInhibitionFieldsAndTargets(IFieldOfView[], PVCoordinatesProvider[], double[]) - 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.
setInitialCapacity(int) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1, this is a no-op.
setInitialJacobians(SpacecraftState, int) - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Set the initial value of the Jacobian with respect to state and parameter.
setInitialJacobians(SpacecraftState, double[][], double[][]) - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Set the initial value of the Jacobian with respect to state and parameter.
setInitialJacobians(SpacecraftState, double[][]) - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Set the initial value of the Jacobian with respect to state.
setInitialJacobians(SpacecraftState, Parameter, double[]) - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Set the initial value of the Jacobian with respect to state.
setInitialMainStateJacobian(double[][]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Set the initial value of the Jacobian matrix with respect to state.
setInitialParameterJacobian(String, double[]) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Set the initial value of a column of the Jacobian matrix with respect to one parameter.
setInitialState(SpacecraftState, double, boolean) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Set the initial state.
setInitialState(SpacecraftState) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set the initial state.
setInitialStep(double) - Method in class org.apache.commons.math3.optimization.general.NonLinearConjugateGradientOptimizer
Deprecated. Set the initial step used to bracket the optimum in line search.
setInitialStepSize(double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Set the initial step size.
setIntegrator(FirstOrderIntegrator) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Set the integrator.
setIntegrator(FirstOrderIntegrator) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Set the integrator.
setIntegrator(UnivariateIntegrator) - Method in class org.apache.commons.math3.analysis.polynomials.FourierDecompositionEngine
Set the UnivariateIntegrator to use for the serires coefficient computation.
setIntegrator(FirstOrderIntegrator) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set the integrator.
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.MultiOrekitStepInterpolator
Set the interpolated date.
setInterpolatedDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
Set the interpolated date.
setInterpolatedDate(AbsoluteDate) - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Set the interpolated date.
setInterpolatedDate(AbsoluteDate) - Method in class org.orekit.propagation.sampling.BasicStepInterpolator
Set the interpolated date.
setInterpolatedDate(AbsoluteDate) - Method in interface org.orekit.propagation.sampling.OrekitStepInterpolator
Set the interpolated date.
setInterpolatedTime(double) - Method in class org.apache.commons.math3.ode.ContinuousOutputModel
Set the time of the interpolated point.
setInterpolatedTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Set the time of the interpolated point.
setInterpolatedTime(double) - Method in interface org.apache.commons.math3.ode.sampling.StepInterpolator
Set the time of the interpolated point.
setInterpolationControl(boolean, int) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Set the interpolation order control parameter.
setIrAcc(boolean) - Method in class fr.cnes.sirius.patrius.assembly.models.RediffusedRadiativeModel
infrared setter
setJacobianWrtParametersEccentric(double[][]) - Method in class org.orekit.orbits.Orbit
 
setJacobianWrtParametersMean(double[][]) - Method in class org.orekit.orbits.Orbit
 
setJacobianWrtParametersTrue(double[][]) - Method in class org.orekit.orbits.Orbit
 
setJulianDay(int) - Method in class org.orekit.files.sp3.SP3File
Set the julian day for this SP3 file.
setKurtosisImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the kurtosis.
setLowerEndPoint(IntervalEndpointType) - Method in class fr.cnes.sirius.patrius.utils.AbstractInterval
 
setLst(double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for lst.
setMainFieldCoefficients(int, int, double, double) - Method in class org.orekit.models.earth.GeoMagneticField
Set 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
setMainTarget(PVCoordinatesProvider, double) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Sets the main target of the sensor property.
setMainTarget(PVCoordinatesProvider, double) - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
Sets the main target of the sensor
setMassCenter(Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.properties.AbstractInertiaProperty
Sets the mass center.
setMassCenter(Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.properties.InertiaSimpleProperty
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 org.orekit.propagation.MassProvider
Set mass derivative to zero.
setMassDerivativeZero(String) - Method in class org.orekit.propagation.SimpleMassModel
Set mass derivative to zero.
setMasterMode(double, MultiOrekitFixedStepHandler) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Set the propagator to master mode with fixed steps.
setMasterMode(MultiOrekitStepHandler) - Method in interface fr.cnes.sirius.patrius.propagation.MultiPropagator
Set the propagator to master mode with variable steps.
setMasterMode(double, MultiOrekitFixedStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Set the propagator to master mode with fixed steps.
setMasterMode(MultiOrekitStepHandler) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Set the propagator to master mode with variable steps.
setMasterMode(double, OrekitFixedStepHandler) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Set the propagator to master mode with fixed steps.
setMasterMode(OrekitStepHandler) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Set the propagator to master mode with variable steps.
setMasterMode(double, OrekitFixedStepHandler) - Method in class org.orekit.propagation.AbstractPropagator
Set the propagator to master mode with fixed steps.
setMasterMode(OrekitStepHandler) - Method in class org.orekit.propagation.AbstractPropagator
Set the propagator to master mode with variable steps.
setMasterMode(double, OrekitFixedStepHandler) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set the propagator to master mode with fixed steps.
setMasterMode(OrekitStepHandler) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set the propagator to master mode with variable steps.
setMasterMode(double, OrekitFixedStepHandler) - Method in interface org.orekit.propagation.Propagator
Set the propagator to master mode with fixed steps.
setMasterMode(OrekitStepHandler) - Method in interface org.orekit.propagation.Propagator
Set the propagator to master mode with variable steps.
setMaxDegree(int) - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Set max degree
setMaxEvals(int) - Method in class org.apache.commons.math3.analysis.polynomials.FourierDecompositionEngine
Set the maximum evaluations allowed for the integrator.
setMaxEvaluations(int) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Set the maximal number of differential equations function evaluations.
setMaxEvaluations(int) - Method in interface org.apache.commons.math3.ode.ODEIntegrator
Set the maximal number of differential equations function evaluations.
setMaxGrowth(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Set the maximal growth factor for stepsize control.
setMaxGrowth(double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Set the maximal growth factor for stepsize control.
setMaximalCount(int) - Method in class org.apache.commons.math3.util.Incrementor
Sets the upper limit for the counter.
setMaxImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the maximum.
setMaxIterations(int) - Method in class org.apache.commons.math3.optimization.linear.AbstractLinearOptimizer
Deprecated. Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in interface org.apache.commons.math3.optimization.linear.LinearOptimizer
Deprecated. Set the maximal number of iterations of the algorithm.
setMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the mean.
setMinImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the minimum.
setMinReduction(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Set the minimal reduction factor for stepsize control.
setMinReduction(double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Set the minimal reduction factor for stepsize control.
setMode(int) - Method in class org.apache.commons.math3.random.ValueServer
Sets the data generation mode.
setMu(double, String) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Set the central attraction coefficient μ.
The Newtonian attraction from the central body force model will be updated with the new coefficient.
setMu(double) - Method in class org.apache.commons.math3.random.ValueServer
Sets the mean used in data generation.
setMu(double) - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
 
setMu(double) - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
Allows to change the value of the gravitational parameter.
setMu(double) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set the central attraction coefficient μ.
The Newtonian attraction from the central body force model will be updated with the new coefficient.
setNoIntercept(boolean) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
 
setNumberOfEpochs(int) - Method in class org.orekit.files.sp3.SP3File
Set the number of epochs as contained in the SP3 file.
setNumElements(int) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.fraction.AbstractFormat
Modify the numerator format.
setOrbit(Orbit) - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
Allows to change the orbit.
setOrbitFrame(String, Frame) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Set a frame for propagation The initial state must have first been added using the MultiNumericalPropagator.addInitialState(SpacecraftState, String) method before defining the associated integration frame.
setOrbitFrame(Frame) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Set propagation frame.
setOrbitFrame(Frame) - Method in class org.orekit.propagation.AbstractPropagator
Set propagation frame.
setOrbitFrame(Frame) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set propagation frame.
setOrbitFrame(Frame) - Method in interface org.orekit.propagation.Propagator
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(OrbitType) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Set propagation orbit type.
setOrbitType(SP3File.SP3OrbitType) - Method in class org.orekit.files.sp3.SP3File
Set the SP3File.SP3OrbitType for this SP3 file.
setOrbitType(OrbitType) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set propagation orbit type.
setOrder(int) - Method in class org.apache.commons.math3.analysis.polynomials.FourierDecompositionEngine
 
setOrderControl(int, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Set the order control parameters.
setOriginOffset(double) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Set the offset of the origin.
setParameter(String, double) - Method in interface org.apache.commons.math3.ode.ParameterizedODE
Set the value for a given parameter.
setParameterizedODE(ParameterizedODE) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Set a parameter Jacobian provider.
setParameterStep(String, double) - Method in class org.apache.commons.math3.ode.JacobianMatrices
Set the step associated to a parameter in order to compute by finite difference the Jacobian matrix.
setPercentileImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation to be used by DescriptiveStatistics.getPercentile(double).
setPoint(int, PointValuePair) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Store a new point at location index.
setPoint(int, PointValuePair) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Store a new point at location index.
setPoints(PointValuePair[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.AbstractSimplex
Replace all points.
setPoints(PointValuePair[]) - Method in class org.apache.commons.math3.optimization.direct.AbstractSimplex
Deprecated. Replace all points.
setPolarMotion(PolarMotion) - Method in class org.orekit.frames.configuration.FramesConfigurationBuilder
Setter for polar motion provider in the builder.
setPolarMotionModel(PolarMotion) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Set the polar motion model.
setPolynomialOrder(int) - Method in class org.orekit.propagation.analytical.covariance.CovarianceInterpolation
 
setPopulationLimit(int) - Method in class org.apache.commons.math3.genetics.ListPopulation
Sets the maximal population size.
setPositionAngleType(PositionAngle) - Method in class fr.cnes.sirius.patrius.propagation.numerical.multi.MultiNumericalPropagator
Set position angle type.
setPositionAngleType(PositionAngle) - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set position angle type.
setPrecessionNutation(PrecessionNutation) - Method in class org.orekit.frames.configuration.FramesConfigurationBuilder
Setter for precession nutation provider in the builder.
setPrecessionNutationModel(PrecessionNutation) - Method in class org.orekit.frames.configuration.FramesConfigurationImplementation
Set the precession nutation model.
setPressure(double) - Method in class org.orekit.propagation.events.ApparentElevationDetector
Set the local pressure at topocentric frame origin if needed.
setPreviousIndex(int) - Method in class org.orekit.utils.AbstractBoundedPVProvider
Set the previous search index
setPrimaryState(double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Set primary part of the current state.
setQuantile(double) - Method in class org.apache.commons.math3.stat.descriptive.rank.Percentile
Sets the value of the quantile field (determines what percentile is computed when evaluate() is called with no quantile argument).
setRandomGenerator(RandomGenerator) - Static method in class org.apache.commons.math3.genetics.GeneticAlgorithm
Set the (static) random generator.
setReadCompleted(boolean) - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
 
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.multi.MultiAdaptedStepHandler
Define new reference date.
setReference(AbsoluteDate) - Method in interface org.orekit.propagation.numerical.ModeHandler
Define new reference date.
setReference(AbsoluteDate) - Method in class org.orekit.propagation.sampling.AdaptedStepHandler
Define new reference date.
setReferenceAxis(Vector3D[]) - Method in class fr.cnes.sirius.patrius.assembly.properties.SensorProperty
Sets the reference axis
setRoundingMode(DfpField.RoundingMode) - Method in class org.apache.commons.math3.dfp.DfpField
Set the rounding mode.
setRoundingMode(RoundingMode) - Method in class org.apache.commons.math3.util.BigReal
Sets the rounding mode for decimal divisions.
setRow(int, T[]) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in row number row as a row matrix.
setRow(int, double[]) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified row of this matrix to the entries of the specified array.
setRow(int, T[]) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in row number row as a row matrix.
setRow(int, double[]) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified row of this matrix to the entries of the specified array.
setRow(int, T[]) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in row number row as a row matrix.
setRow(int, double[]) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified row of this matrix to the entries of the specified array.
setRowMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in row number row as a row matrix.
setRowMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified row of this matrix to the entries of the specified row matrix.
setRowMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in row number row as a row matrix.
setRowMatrix(int, BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified row of this matrix to the entries of the specified row matrix.
setRowMatrix(int, BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in row number row as a row matrix.
setRowMatrix(int, RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified row of this matrix to the entries of the specified row matrix.
setRowVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Set the entries in row number row as a vector.
setRowVector(int, RealVector) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Sets the specified row of this matrix to the entries of the specified vector.
setRowVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Set the entries in row number row as a vector.
setRowVector(int, RealVector) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Sets the specified row of this matrix to the entries of the specified vector.
setRowVector(int, FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Set the entries in row number row as a vector.
setRowVector(int, RealVector) - Method in interface org.apache.commons.math3.linear.RealMatrix
Sets the specified row of this matrix to the entries of the specified vector.
setSafety(double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Set the safety factor for stepsize control.
setSafety(double) - Method in class org.apache.commons.math3.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Set the safety factor for stepsize control.
setSatelliteId(String) - Method in class org.orekit.files.general.SatelliteInformation
Set the id of this satellite.
setScale(int) - Method in class org.apache.commons.math3.util.BigReal
Sets the scale for division operations.
setSec(double) - Method in class org.orekit.forces.atmospheres.MSIS2000.Input
Setter for doy.
setSecondaryState(int, double[]) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Set secondary part of the current state.
setSecondCovarianceMatrix(RealMatrix, AbsoluteDate) - Method in class org.orekit.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 org.orekit.files.sp3.SP3File
Set the seconds of the GPS week for this SP3 file.
setSecularVariationCoefficients(int, int, double, double) - Method in class org.orekit.models.earth.GeoMagneticField
Set the given secular variation coefficients.
setSecureAlgorithm(String, String) - Method in class org.apache.commons.math3.random.RandomDataGenerator
Sets the PRNG algorithm for the underlying SecureRandom instance using the Security Provider API.
setSecureAlgorithm(String, String) - Method in class org.apache.commons.math3.random.RandomDataImpl
Deprecated. Sets the PRNG algorithm for the underlying SecureRandom instance using the Security Provider API.
setSeed(int) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.AbstractRandomGenerator
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.AbstractWell
Reinitialize the generator as if just built with the given int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.AbstractWell
Reinitialize the generator as if just built with the given int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.AbstractWell
Reinitialize the generator as if just built with the given long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.BitsStreamGenerator
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.ISAACRandom
Sets the seed of the underlying random number generator using an int seed.
setSeed(long) - Method in class org.apache.commons.math3.random.ISAACRandom
Sets the seed of the underlying random number generator using a long seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.ISAACRandom
Sets the seed of the underlying random number generator using an int array seed.
setSeed(int) - Method in class org.apache.commons.math3.random.JDKRandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.JDKRandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(int) - Method in class org.apache.commons.math3.random.MersenneTwister
Reinitialize the generator as if just built with the given int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.MersenneTwister
Reinitialize the generator as if just built with the given int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.MersenneTwister
Reinitialize the generator as if just built with the given long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.RandomAdaptor
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.RandomAdaptor
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.RandomAdaptor
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in interface org.apache.commons.math3.random.RandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in interface org.apache.commons.math3.random.RandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in interface org.apache.commons.math3.random.RandomGenerator
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math3.random.SynchronizedRandomGenerator
Sets the seed of the underlying random number generator using a long seed.
setSigma(double) - Method in class org.apache.commons.math3.random.ValueServer
Sets the standard deviation used in ValueServer.GAUSSIAN_MODE.
setSimplex(AbstractSimplex) - Method in class org.apache.commons.math3.optimization.direct.SimplexOptimizer
Deprecated. As of 3.1. The initial simplex can now be passed as an argument of the BaseAbstractMultivariateOptimizer.optimize(int,MultivariateFunction,GoalType,OptimizationData[]) method.
setSize(double) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Set the size of the instance.
setSkewnessImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the skewness.
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.stela.propagation.StelaAbstractPropagator
Set the propagator to slave mode.
setSlaveMode() - Method in class org.orekit.propagation.AbstractPropagator
Set the propagator to slave mode.
setSlaveMode() - Method in class org.orekit.propagation.numerical.NumericalPropagator
Set the propagator to slave mode.
setSlaveMode() - Method in interface org.orekit.propagation.Propagator
Set the propagator to slave mode.
setSoftCurrentTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Restrict step range to a limited part of the global step.
setSoftPreviousTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Restrict step range to a limited part of the global step.
setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesHarmonicProfile
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.guidance.AngularVelocitiesPolynomialProfile
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.guidance.QuaternionHarmonicProfile
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class fr.cnes.sirius.patrius.guidance.QuaternionPolynomialProfile
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.AbstractAttitudeLaw
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.AttitudeLawLeg
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.AttitudeLegLaw
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.AttitudeLegsSequence
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in interface org.orekit.attitudes.AttitudeProvider
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.AttitudesSequence
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.ConstantSpinSlew
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.GroundPointingWrapper
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.LofOffsetPointing
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.RelativeTabulatedAttitudeLaw
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.RelativeTabulatedAttitudeLeg
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.TabulatedAttitude
Method to activate spin derivative computation.
setSpinDerivativesComputation(boolean) - Method in class org.orekit.attitudes.TwoSpinBiasSlew
Method to activate spin derivative computation.
setStabilityCheck(boolean, int, int, double) - Method in class org.apache.commons.math3.ode.nonstiff.GraggBulirschStoerIntegrator
Set the stability check controls.
setStartDate(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaAbstractPropagator
Set a start date.
setStartDate(AbsoluteDate) - Method in class org.orekit.propagation.AbstractPropagator
Set a start date.
setStarterIntegrator(FirstOrderIntegrator) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Set the starter integrator.
setStateInitialized(boolean) - Method in class org.apache.commons.math3.ode.AbstractIntegrator
Set the stateInitialized flag.
setSteps(double) - Method in class org.orekit.propagation.numerical.PartialDerivativesEquations
Set the step for finite differences with respect to spacecraft position.
setStepSizeControl(double, double, double, double) - Method in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Set the adaptive step size control parameters.
setStepSizeControl(double, double, double[], double[]) - Method in class org.apache.commons.math3.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.
setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Replace the submatrix starting at (row, column) using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Replace the submatrix starting at (row, column) using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Replace the submatrix starting at (row, column) using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(T[][], int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Replace the submatrix starting at (row, column) using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrixWithMatrix(RealMatrix, int, int) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Method setSubMatrix using a RealMatrix for subMatrix instead of an array
setSubVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Set a set of consecutive elements.
setSubVector(int, RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Set a sequence of consecutive elements.
setSubVector(int, double[]) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Set a set of consecutive elements.
setSubVector(int, FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Set a set of consecutive elements.
setSubVector(int, RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Set a sequence of consecutive elements.
setSubVector(int, RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Set a sequence of consecutive elements.
setSubVector(int, FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Set a set of consecutive elements.
setSumImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the sum.
setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the Sum.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.moment.GeometricMean
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the sum of logs.
setSumsqImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the sum of squares.
setSun(PVCoordinatesProvider) - Method in class org.orekit.propagation.events.NadirSolarIncidenceDetector
Sets the sun PVCoordinatesProvider
setSwitches(int, int) - Method in class org.orekit.forces.atmospheres.MSIS2000.Flags
Setter for a specific element of the switches array.
setSwitches(int[]) - Method in class org.orekit.forces.atmospheres.MSIS2000.Flags
Setter for switches.
setTemperature(double) - Method in class org.orekit.propagation.events.ApparentElevationDetector
Set the local temperature at topocentric frame origin if needed.
setThreshold(int, double) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ComparisonData
Sets the threshold related to a column.
setThreshold(double) - Method in class org.orekit.propagation.analytical.AbstractLyddanePropagator
Setter for relative convergence threshold for osculating to mean algorithm.
setThreshold(double) - Static method in class org.orekit.propagation.analytical.EcksteinHechlerPropagator
Setter for osculating to mean conversion relative convergence threshold.
setThresholds(ArrayList<Double>) - Method in class fr.cnes.sirius.patrius.tools.ephemerisComparator.ComparisonData
Sets the threshold related to a column.
setTime(double) - Method in class org.apache.commons.math3.ode.ExpandableStatefulODE
Set current time.
setTimeInterval(AbsoluteDateInterval) - Method in class org.orekit.attitudes.TabulatedAttitude
Return a new law with the specified interval.
setTimeout(int) - Method in class org.orekit.data.NetworkCrawler
Set the timeout for connection.
setTimeSystem(OrbitFile.TimeSystem) - Method in class org.orekit.files.sp3.SP3File
Set the time system used in this SP3 file.
setTransform(Transform) - Method in class org.orekit.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.
setTScale(TimeScale) - Method in class fr.cnes.sirius.patrius.tools.force.validation.PVEphemerisLoader
Set the TimeScale for AbsoluteDate management.
setType(SP3File.SP3FileType) - Method in class org.orekit.files.sp3.SP3File
Set the file type for this SP3 file.
Setup - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
The purpose of this class is to load and represent the setup data for the ephemeris comparator.
Setup(String) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.Setup
Constructor.
setup(int, UnivariateFunction, double, double) - Method in class org.apache.commons.math3.analysis.integration.BaseAbstractUnivariateIntegrator
Prepare for computation.
setup(int, DifferentiableUnivariateFunction, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.AbstractDifferentiableUnivariateSolver
Deprecated. Prepare for computation.
setup(int, PolynomialFunction, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.AbstractPolynomialSolver
Prepare for computation.
setup(int, UnivariateDifferentiableFunction, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.AbstractUnivariateDifferentiableSolver
Prepare for computation.
setup(int, FUNC, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Prepare for computation.
setUp() - Method in class org.apache.commons.math3.optimization.direct.BaseAbstractMultivariateVectorOptimizer
Deprecated. Method which a subclass must override whenever its internal state depend on the input parsed by this base class.
setUp() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. Method which a subclass must override whenever its internal state depend on the input parsed by this base class.
setUpEventDetector(EventDetector, Map<String, AttitudeProvider>, Map<String, AttitudeProvider>, 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, AttitudeProvider>, Map<String, AttitudeProvider>) - 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 org.orekit.propagation.numerical.NumericalPropagator
Wrap an Orekit event detector and register it to the integrator.
setUpperEndPoint(IntervalEndpointType) - Method in class fr.cnes.sirius.patrius.utils.AbstractInterval
 
setValue(String, Object) - Method in class org.apache.commons.math3.exception.util.ExceptionContext
Sets the context (key, value) pair.
setValue(double) - Method in class org.apache.commons.math3.linear.OpenMapRealVector.OpenMapEntry
Deprecated. Set the value of the entry.
setValue(double) - Method in class org.apache.commons.math3.linear.RealVector.Entry
Set the value of the entry.
setValue(double) - Method in class org.orekit.parameter.Parameter
Setting parameter value.
setValuesFileURL(String) - Method in class org.apache.commons.math3.random.ValueServer
Sets the values file URL using a string URL representation.
setValuesFileURL(URL) - Method in class org.apache.commons.math3.random.ValueServer
Sets the the values file URL.
setVarianceDirection(SemiVariance.Direction) - Method in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
Sets the variance direction
setVarianceImpl(UnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Sets the implementation for the variance.
setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Sets the implementation for the variance.
setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the variance.
setWholeFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.ProperBigFractionFormat
Modify the whole format.
setWholeFormat(NumberFormat) - Method in class org.apache.commons.math3.fraction.ProperFractionFormat
Modify the whole format.
setWindowSize(int) - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
WindowSize controls the number of values that contribute to the reported statistics.
setWindowSize(int) - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
WindowSize controls the number of values that contribute to the reported statistics.
setYear(int) - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Set file year
SEVEN_POINT_FIVE - Static variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Constant 7.5
SGP - Static variable in class org.orekit.propagation.analytical.tle.TLE
Identifier for SGP type of ephemeris.
SGP4 - Static variable in class org.orekit.propagation.analytical.tle.TLE
Identifier for SGP4 type of ephemeris.
SGP8 - Static variable in class org.orekit.propagation.analytical.tle.TLE
Identifier for SGP8 type of ephemeris.
Shape - Interface in org.apache.commons.math3.geometry.euclidean.threed
Interface for all shapes.
shift(double[], double) - Static method in class org.apache.commons.math3.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 org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Shift one step forward.
shift() - Method in class org.orekit.propagation.sampling.BasicStepInterpolator
Shift one step forward.
shiftedBy(double) - Method in class org.orekit.attitudes.Attitude
Get a time-shifted attitude.
shiftedBy(double) - Method in class org.orekit.frames.transformations.Transform
Get a time-shifted instance.
shiftedBy(double, boolean) - Method in class org.orekit.frames.transformations.Transform
Get a time-shifted instance.
shiftedBy(double) - Method in class org.orekit.orbits.Orbit
Call the method Orbit.orbitShiftedBy(double) implemented in inherited classes of Orbit.
shiftedBy(double) - Method in class org.orekit.propagation.SpacecraftState
Get a time-shifted state.
shiftedBy(double) - Method in class org.orekit.time.AbsoluteDate
Get a time-shifted date.
shiftedBy(double) - Method in interface org.orekit.time.TimeShiftable
Get a time-shifted instance.
shiftedBy(double) - Method in class org.orekit.utils.AngularCoordinates
Get a time-shifted state.
shiftedBy(double, boolean) - Method in class org.orekit.utils.AngularCoordinates
Get a time-shifted state.
shiftedBy(double) - Method in class org.orekit.utils.PVCoordinates
Get a time-shifted state.
shiftedBy(double, boolean) - Method in class org.orekit.utils.TimeStampedAngularCoordinates
Get a time-shifted state.
shiftedBy(double) - Method in class org.orekit.utils.TimeStampedAngularCoordinates
Get a time-shifted state.
shiftedBy(double) - Method in class org.orekit.utils.TimeStampedPVCoordinates
Get a time-shifted state.
shiftLeft() - Method in class org.apache.commons.math3.dfp.Dfp
Shift the mantissa left, and adjust the exponent to compensate.
shiftRight() - Method in class org.apache.commons.math3.dfp.Dfp
Shift the mantissa right, and adjust the exponent to compensate.
SHM_FILENAME - Static variable in class org.orekit.forces.gravity.potential.GravityFieldFactory
Default regular expression for SHM files.
SHMFormatReader - Class in org.orekit.forces.gravity.potential
Reader for the SHM gravity field format.
SHMFormatReader(String, boolean) - Constructor for class org.orekit.forces.gravity.potential.SHMFormatReader
Simple constructor.
shortValue() - Method in class org.apache.commons.math3.util.Decimal64
The current implementation performs casting to a short.
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.CentralBodyMaskCircularFOVDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.CombinedPhenomenaDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.EarthZoneDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.GenericCodingEventDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.multi.MultiGenericCodingEventDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.sensor.ExtremaSightAxisDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.sensor.MaskingDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.sensor.RFVisibilityDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.sensor.SatToSatMutualVisibilityDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.sensor.SensorInhibitionDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.sensor.SensorVisibilityDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.sensor.StationToSatMutualVisibilityDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMonoEventDetector
This method is called after the step handler has returned and before the next step is started, but only when EventHandler.eventOccurred(double, double[], boolean, boolean) has been called.
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.AdaptedMultiEventDetector
This method is called after the step handler has returned and before the next step is started, but only when EventHandler.eventOccurred(double, double[], boolean, boolean) has been called.
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.MultiAbstractDetector
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.propagation.events.multi.OneSatEventDetectorWrapper
 
shouldBeRemoved() - Method in class fr.cnes.sirius.patrius.stela.PerigeeAltitudeDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in interface org.apache.commons.math3.ode.events.EventHandler
This method is called after the step handler has returned and before the next step is started, but only when EventHandler.eventOccurred(double, double[], boolean, boolean) has been called.
shouldBeRemoved() - Method in class org.orekit.forces.maneuvers.ImpulseManeuver
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.AbstractDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.AdaptedEventDetector
This method is called after the step handler has returned and before the next step is started, but only when EventHandler.eventOccurred(double, double[], boolean, boolean) has been called.
shouldBeRemoved() - Method in class org.orekit.propagation.events.AlignmentDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.AltitudeDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.AnomalyDetector
 
shouldBeRemoved() - Method in class org.orekit.propagation.events.AOLDetector
 
shouldBeRemoved() - Method in class org.orekit.propagation.events.ApparentElevationDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.ApsideDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.BetaAngleDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.CircularFieldOfViewDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.DateDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.DihedralFieldOfViewDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.DistanceDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.EclipseDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.ElevationDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in interface org.orekit.propagation.events.EventDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.EventShifter
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.ExtremaDistanceDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.ExtremaElevationDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.ExtremaLatitudeDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.ExtremaLongitudeDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector
 
shouldBeRemoved() - Method in class org.orekit.propagation.events.GroundMaskElevationDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.LatitudeDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.LocalTimeDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.LongitudeDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in interface org.orekit.propagation.events.multi.MultiEventDetector
This method is called after the step handler has returned and before the next step is started, but only when MultiEventDetector.eventOccurred(java.util.Map, boolean, boolean) has been called.
shouldBeRemoved() - Method in class org.orekit.propagation.events.NadirSolarIncidenceDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.NodeDetector
 
shouldBeRemoved() - Method in class org.orekit.propagation.events.NthOccurrenceDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.NullMassDetector
 
shouldBeRemoved() - Method in class org.orekit.propagation.events.NullMassPartDetector
 
shouldBeRemoved() - Method in class org.orekit.propagation.events.SolarTimeDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
shouldBeRemoved() - Method in class org.orekit.propagation.events.ThreeBodiesAngleDetector
This method is called after EventDetector.eventOccurred(org.orekit.propagation.SpacecraftState, boolean, boolean) has been triggered.
side(Hyperplane<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
Compute the relative position of the instance with respect to an hyperplane.
side(Hyperplane<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubPlane
Compute the relative position of the instance with respect to an hyperplane.
side(Hyperplane<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Compute the relative position of the instance with respect to an hyperplane.
side(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractRegion
Compute the relative position of the instance with respect to an hyperplane.
side(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Compute the relative position of the instance with respect to an hyperplane.
side(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Region
Compute the relative position of the instance with respect to an hyperplane.
Side - Enum in org.apache.commons.math3.geometry.partitioning
Enumerate representing the location of an element with respect to an hyperplane of a space.
side(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Compute the relative position of the instance with respect to an hyperplane.
Sigmoid - Class in org.apache.commons.math3.analysis.function
Sigmoid function.
Sigmoid() - Constructor for class org.apache.commons.math3.analysis.function.Sigmoid
Usual sigmoid function, where the lower asymptote is 0 and the higher asymptote is 1.
Sigmoid(double, double) - Constructor for class org.apache.commons.math3.analysis.function.Sigmoid
Sigmoid function.
Sigmoid.Parametric - Class in org.apache.commons.math3.analysis.function
Parametric function where the input array contains the parameters of the logit function, ordered as follows: Lower asymptote Higher asymptote
Sigmoid.Parametric() - Constructor for class org.apache.commons.math3.analysis.function.Sigmoid.Parametric
 
sign - Variable in class org.apache.commons.math3.dfp.Dfp
Sign bit: 1 for positive, -1 for negative.
SignalPropagation - Class in fr.cnes.sirius.patrius.signalpropagation
This class describes the propagation of a signal in space
SignalPropagation(Vector3D, AbsoluteDate, AbsoluteDate, Frame, SignalPropagationModel.FixedDate) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.SignalPropagation
Constructor with computation of one of the dates
SignalPropagationModel - Class in fr.cnes.sirius.patrius.signalpropagation
Model for the computation of a signal propagation vector and toolbox for the different corrections to be applied to it.
SignalPropagationModel(Frame, double) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.SignalPropagationModel
Constructor of the signal propagation model.
SignalPropagationModel.FixedDate - Enum in fr.cnes.sirius.patrius.signalpropagation
the fixed date of computation
signum() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Compute the signum of the instance.
Signum - Class in org.apache.commons.math3.analysis.function
signum function.
Signum() - Constructor for class org.apache.commons.math3.analysis.function.Signum
 
signum() - Method in interface org.apache.commons.math3.RealFieldElement
Compute the signum of the instance.
signum(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the signum of a number.
signum(float) - Static method in class org.apache.commons.math3.util.FastMath
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 org.apache.commons.math3.optim
Simple optimization constraints: lower and upper bounds.
SimpleBounds(double[], double[]) - Constructor for class org.apache.commons.math3.optim.SimpleBounds
 
SimpleBounds - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
SimpleBounds(double[], double[]) - Constructor for class org.apache.commons.math3.optimization.SimpleBounds
Deprecated.  
SimpleExponentialAtmosphere - Class in org.orekit.forces.atmospheres
Simple exponential atmospheric model.
SimpleExponentialAtmosphere(BodyShape, double, double, double) - Constructor for class org.orekit.forces.atmospheres.SimpleExponentialAtmosphere
Create an exponential atmosphere.
SimpleMassModel - Class in org.orekit.propagation
Simple implementation of MassProvider.
SimpleMassModel(double, String) - Constructor for class org.orekit.propagation.SimpleMassModel
Constructor.
SimplePointChecker<PAIR extends Pair<double[],? extends Object>> - Class in org.apache.commons.math3.optim
Simple implementation of the ConvergenceChecker interface using only point coordinates.
SimplePointChecker(double, double) - Constructor for class org.apache.commons.math3.optim.SimplePointChecker
Build an instance with specified thresholds.
SimplePointChecker(double, double, int) - Constructor for class org.apache.commons.math3.optim.SimplePointChecker
Builds an instance with specified thresholds.
SimplePointChecker<PAIR extends Pair<double[],? extends Object>> - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
SimplePointChecker() - Constructor for class org.apache.commons.math3.optimization.SimplePointChecker
Deprecated. See AbstractConvergenceChecker.AbstractConvergenceChecker()
SimplePointChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.SimplePointChecker
Deprecated. Build an instance with specified thresholds.
SimplePointChecker(double, double, int) - Constructor for class org.apache.commons.math3.optimization.SimplePointChecker
Deprecated. Builds an instance with specified thresholds.
SimpleRegression - Class in org.apache.commons.math3.stat.regression
Estimates an ordinary least squares regression model with one independent variable.
SimpleRegression() - Constructor for class org.apache.commons.math3.stat.regression.SimpleRegression
Create an empty SimpleRegression instance
SimpleRegression(boolean) - Constructor for class org.apache.commons.math3.stat.regression.SimpleRegression
Create a SimpleRegression instance, specifying whether or not to estimate an intercept.
SimpleUnivariateValueChecker - Class in org.apache.commons.math3.optim.univariate
Simple implementation of the ConvergenceChecker interface that uses only objective function values.
SimpleUnivariateValueChecker(double, double) - Constructor for class org.apache.commons.math3.optim.univariate.SimpleUnivariateValueChecker
Build an instance with specified thresholds.
SimpleUnivariateValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optim.univariate.SimpleUnivariateValueChecker
Builds an instance with specified thresholds.
SimpleUnivariateValueChecker - Class in org.apache.commons.math3.optimization.univariate
Deprecated. As of 3.1 (to be removed in 4.0).
SimpleUnivariateValueChecker() - Constructor for class org.apache.commons.math3.optimization.univariate.SimpleUnivariateValueChecker
Deprecated. See AbstractConvergenceChecker.AbstractConvergenceChecker()
SimpleUnivariateValueChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.univariate.SimpleUnivariateValueChecker
Deprecated. Build an instance with specified thresholds.
SimpleUnivariateValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optimization.univariate.SimpleUnivariateValueChecker
Deprecated. Builds an instance with specified thresholds.
SimpleValueChecker - Class in org.apache.commons.math3.optim
Simple implementation of the ConvergenceChecker interface using only objective function values.
SimpleValueChecker(double, double) - Constructor for class org.apache.commons.math3.optim.SimpleValueChecker
Build an instance with specified thresholds.
SimpleValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optim.SimpleValueChecker
Builds an instance with specified thresholds.
SimpleValueChecker - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
SimpleValueChecker() - Constructor for class org.apache.commons.math3.optimization.SimpleValueChecker
Deprecated. See AbstractConvergenceChecker.AbstractConvergenceChecker()
SimpleValueChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.SimpleValueChecker
Deprecated. Build an instance with specified thresholds.
SimpleValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optimization.SimpleValueChecker
Deprecated. Builds an instance with specified thresholds.
SimpleVectorValueChecker - Class in org.apache.commons.math3.optim
Simple implementation of the ConvergenceChecker interface using only objective function values.
SimpleVectorValueChecker(double, double) - Constructor for class org.apache.commons.math3.optim.SimpleVectorValueChecker
Build an instance with specified thresholds.
SimpleVectorValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optim.SimpleVectorValueChecker
Builds an instance with specified tolerance thresholds and iteration count.
SimpleVectorValueChecker - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
SimpleVectorValueChecker() - Constructor for class org.apache.commons.math3.optimization.SimpleVectorValueChecker
Deprecated. See AbstractConvergenceChecker.AbstractConvergenceChecker()
SimpleVectorValueChecker(double, double) - Constructor for class org.apache.commons.math3.optimization.SimpleVectorValueChecker
Deprecated. Build an instance with specified thresholds.
SimpleVectorValueChecker(double, double, int) - Constructor for class org.apache.commons.math3.optimization.SimpleVectorValueChecker
Deprecated. Builds an instance with specified tolerance thresholds and iteration count.
SimplexOptimizer - Class in org.apache.commons.math3.optim.nonlinear.scalar.noderiv
This class implements simplex-based direct search optimization.
SimplexOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.SimplexOptimizer
 
SimplexOptimizer(double, double) - Constructor for class org.apache.commons.math3.optim.nonlinear.scalar.noderiv.SimplexOptimizer
 
SimplexOptimizer - Class in org.apache.commons.math3.optimization.direct
Deprecated. As of 3.1 (to be removed in 4.0).
SimplexOptimizer() - Constructor for class org.apache.commons.math3.optimization.direct.SimplexOptimizer
Deprecated. See SimpleValueChecker.SimpleValueChecker()
SimplexOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.apache.commons.math3.optimization.direct.SimplexOptimizer
Deprecated.  
SimplexOptimizer(double, double) - Constructor for class org.apache.commons.math3.optimization.direct.SimplexOptimizer
Deprecated.  
SimplexSolver - Class in org.apache.commons.math3.optim.linear
Solves a linear problem using the "Two-Phase Simplex" method.
SimplexSolver() - Constructor for class org.apache.commons.math3.optim.linear.SimplexSolver
Builds a simplex solver with default settings.
SimplexSolver(double, int) - Constructor for class org.apache.commons.math3.optim.linear.SimplexSolver
Builds a simplex solver with a specified accepted amount of error.
SimplexSolver - Class in org.apache.commons.math3.optimization.linear
Deprecated. As of 3.1 (to be removed in 4.0).
SimplexSolver() - Constructor for class org.apache.commons.math3.optimization.linear.SimplexSolver
Deprecated. Build a simplex solver with default settings.
SimplexSolver(double, int) - Constructor for class org.apache.commons.math3.optimization.linear.SimplexSolver
Deprecated. Build a simplex solver with a specified accepted amount of error
SIMPSON_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
Maximal number of iterations for Simpson.
SimpsonIntegrator - Class in org.apache.commons.math3.analysis.integration
Implements Simpson's Rule for integration of real univariate functions.
SimpsonIntegrator(double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
Build a Simpson integrator with given accuracies and iterations counts.
SimpsonIntegrator(int, int) - Constructor for class org.apache.commons.math3.analysis.integration.SimpsonIntegrator
Build a Simpson integrator with given iteration counts.
SimpsonIntegrator() - Constructor for class org.apache.commons.math3.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.
sin() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Sine operation.
sin(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute sine of a derivative structure.
Sin - Class in org.apache.commons.math3.analysis.function
Sine function.
Sin() - Constructor for class org.apache.commons.math3.analysis.function.Sin
 
sin() - Method in class org.apache.commons.math3.complex.Complex
Compute the sine of this complex number.
sin(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the sine of the argument.
sin() - Method in interface org.apache.commons.math3.RealFieldElement
Sine operation.
sin(double) - Static method in class org.apache.commons.math3.util.FastMath
Sine function.
SIN_I_LIM - Static variable in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Sinus of half limit inclination in type 8.
Sinc - Class in org.apache.commons.math3.analysis.function
Sinc function, defined by
Sinc() - Constructor for class org.apache.commons.math3.analysis.function.Sinc
The sinc function, sin(x) / x.
Sinc(boolean) - Constructor for class org.apache.commons.math3.analysis.function.Sinc
Instantiates the sinc function.
SingularMatrixException - Exception in org.apache.commons.math3.linear
Exception to be thrown when a non-singular matrix is expected.
SingularMatrixException() - Constructor for exception org.apache.commons.math3.linear.SingularMatrixException
Construct an exception.
SingularOperatorException - Exception in org.apache.commons.math3.linear
Exception to be thrown when trying to invert a singular operator.
SingularOperatorException() - Constructor for exception org.apache.commons.math3.linear.SingularOperatorException
Creates a new instance of this class.
SingularValueDecomposition - Class in org.apache.commons.math3.linear
Calculates the compact Singular Value Decomposition of a matrix.
SingularValueDecomposition(RealMatrix) - Constructor for class org.apache.commons.math3.linear.SingularValueDecomposition
Calculates the compact Singular Value Decomposition of the given matrix.
sinh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Hyperbolic sine operation.
sinh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute hyperbolic sine of a derivative structure.
Sinh - Class in org.apache.commons.math3.analysis.function
Hyperbolic sine function.
Sinh() - Constructor for class org.apache.commons.math3.analysis.function.Sinh
 
sinh() - Method in class org.apache.commons.math3.complex.Complex
Compute the hyperbolic sine of this complex number.
sinh() - Method in interface org.apache.commons.math3.RealFieldElement
Hyperbolic sine operation.
sinh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the hyperbolic sine of a number.
sini0 - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
sinus original inclination.
sinInternal(Dfp[]) - Static method in class org.apache.commons.math3.dfp.DfpMath
Computes sin(a) Used when 0 < a < pi/4.
SIXTY - Static variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Constant 60
size() - Method in class org.apache.commons.math3.geometry.partitioning.utilities.AVLTree
Get the number of elements of the tree.
size() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap
Get the number of elements stored in the map.
size() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap
Get the number of elements stored in the map.
size() - Method in class org.orekit.frames.configuration.eop.AbstractEOPHistory
Get the number of entries in the history.
size() - Method in interface org.orekit.frames.configuration.eop.EOPHistory
Get the number of entries in the history.
size() - Method in class org.orekit.frames.configuration.eop.NoEOP2000History
size.
Skewness - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the skewness of the available values.
Skewness() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Skewness
Constructs a Skewness
Skewness(ThirdMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Skewness
Constructs a Skewness with an external moment
Skewness(Skewness) - Constructor for class org.apache.commons.math3.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 org.orekit.propagation.Propagator
Indicator for slave mode.
slerp(Rotation, Rotation, double) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Returns spherical linear interpolated rotation.
slerp(AbsoluteDate, Attitude, Attitude, Frame, boolean) - Static method in class org.orekit.attitudes.Attitude
The slerp interpolation method is efficient but is less accurate than the interpolate method.
SlerpInterpolator - Class in org.orekit.attitudes.kinematics
Deprecated. since 3.1 use instead Attitude.interpolate(AbsoluteDate, Collection) or Attitude.slerp(AbsoluteDate, Attitude, Attitude, Frame, boolean)
SlerpInterpolator() - Constructor for class org.orekit.attitudes.kinematics.SlerpInterpolator
Deprecated. Simple constructor.
Slew - Interface in org.orekit.attitudes
This interface represents a slew model set.
SmallManeuverAnalyticalModel - Class in org.orekit.forces.maneuvers
Analytical model for small maneuvers.
SmallManeuverAnalyticalModel(SpacecraftState, Vector3D, double, String) - Constructor for class org.orekit.forces.maneuvers.SmallManeuverAnalyticalModel
Build a maneuver defined in spacecraft frame.
SmallManeuverAnalyticalModel(SpacecraftState, Frame, Vector3D, double, String) - Constructor for class org.orekit.forces.maneuvers.SmallManeuverAnalyticalModel
Build a maneuver defined in user-specified frame.
smooth(double[], double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Compute a weighted loess fit on the data at the original abscissae.
smooth(double[], double[]) - Method in class org.apache.commons.math3.analysis.interpolation.LoessInterpolator
Compute a loess fit on the data at the original abscissae.
SmoothingPolynomialBicubicSplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Generates a bicubic interpolation function.
SmoothingPolynomialBicubicSplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
Default constructor.
SmoothingPolynomialBicubicSplineInterpolator(int) - Constructor for class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
 
SmoothingPolynomialBicubicSplineInterpolator(int, int) - Constructor for class org.apache.commons.math3.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
 
SNAN - Static variable in class org.apache.commons.math3.dfp.Dfp
Indicator value for signaling NaN.
SOLAR_SYSTEM_BARYCENTER - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for solar system barycenter.
SolarActivityDataFactory - Class in org.orekit.forces.atmospheres.solarActivity
Factory used to read solar activity files and return solar activity data providers
SolarActivityDataProvider - Interface in org.orekit.forces.atmospheres.solarActivity
Interface for solar activity data providers, to be used for atmosphere models
SolarActivityDataReader - Class in org.orekit.forces.atmospheres.solarActivity
Represents a basic solar activity file reader.
SolarActivityDataReader(String, TimeScale) - Constructor for class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Constructor.
SolarActivityToolbox - Class in org.orekit.forces.atmospheres.solarActivity
Solar activity toolbox.
SolarRadiationPressure - Class in org.orekit.forces.radiation
Solar radiation pressure force model.
SolarRadiationPressure(PVCoordinatesProvider, double, RadiationSensitive) - Constructor for class org.orekit.forces.radiation.SolarRadiationPressure
Simple constructor with default reference values.
SolarRadiationPressure(PVCoordinatesProvider, double, RadiationSensitive, boolean) - Constructor for class org.orekit.forces.radiation.SolarRadiationPressure
Simple constructor with default reference values.
SolarRadiationPressure(double, double, PVCoordinatesProvider, double, RadiationSensitive) - Constructor for class org.orekit.forces.radiation.SolarRadiationPressure
Complete constructor.
SolarRadiationPressure(double, double, PVCoordinatesProvider, double, RadiationSensitive, boolean) - Constructor for class org.orekit.forces.radiation.SolarRadiationPressure
Complete constructor.
SolarRadiationPressure(Parameter, PVCoordinatesProvider, double, RadiationSensitive) - Constructor for class org.orekit.forces.radiation.SolarRadiationPressure
Complete constructor.
SolarRadiationPressure(Parameter, PVCoordinatesProvider, double, RadiationSensitive, boolean) - Constructor for class org.orekit.forces.radiation.SolarRadiationPressure
Complete constructor.
SolarRadiationWrench - Class in fr.cnes.sirius.patrius.wrenches
This class represents a solar radiation wrench model.
SolarRadiationWrench(PVCoordinatesProvider, GeometricBodyShape, RadiationWrenchSensitive) - Constructor for class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
Simple constructor with default reference values.
SolarRadiationWrench(double, double, double, PVCoordinatesProvider, GeometricBodyShape, RadiationWrenchSensitive) - Constructor for class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
Complete constructor.
SolarRadiationWrench(Parameter, Parameter, Parameter, PVCoordinatesProvider, GeometricBodyShape, RadiationWrenchSensitive) - Constructor for class fr.cnes.sirius.patrius.wrenches.SolarRadiationWrench
Complete constructor using Parameter.
SolarTimeDetector - Class in org.orekit.propagation.events
Detects when the solar time of a spacecraft is equal to a predetermined value.
The solar time is represented by the angle between the projections of the Sun in the osculator orbital plane and the satellite position; therefore this angle is equal to zero when the solar time is 12.00h and Π when the solar time is 0.00h.
SolarTimeDetector(double) - Constructor for class org.orekit.propagation.events.SolarTimeDetector
Constructor for a SolarTimeDetector instance.
SolarTimeDetector(double, double, double) - Constructor for class org.orekit.propagation.events.SolarTimeDetector
Constructor for a SolarTimeDetector instance with complimentary parameters.
SolarTimeDetector(double, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.SolarTimeDetector
Constructor for a SolarTimeDetector instance with complimentary parameters.
SolarTimeDetector(double, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.SolarTimeDetector
Constructor for a SolarTimeDetector instance with complimentary parameters.
solidEarthTidesCorrections(AbsoluteDate, Vector3D, Vector3D, Vector3D) - Static method in class org.orekit.utils.ReferencePointsDisplacement
Computes the displacement of reference points due to the effect of the solid Earth tides.
SolidShape - Interface in org.apache.commons.math3.geometry.euclidean.threed
Interface for all solids.
SolidTidesAcc - Class in fr.cnes.sirius.patrius.stela.forces.gravity
Class representing the tidal contribution.
SolidTidesAcc(CelestialBody, CelestialBody) - 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, CelestialBody, CelestialBody) - 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, FUNC, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Solve for a zero in the given interval, start at startValue.
solve(int, FUNC, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Solve for a zero root in the given interval.
solve(int, FUNC, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Solve for a zero in the vicinity of startValue.
solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Solve for a zero in the given interval.
solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Solve for a zero in the given interval, start at startValue.
solve(int, UnivariateFunction, double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseSecantSolver
Solve for a zero in the given interval, start at startValue.
solve(int, FUNC, double, double) - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Solve for a zero root in the given interval.
solve(int, FUNC, double, double, double) - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Solve for a zero in the given interval, start at startValue.
solve(int, FUNC, double) - Method in interface org.apache.commons.math3.analysis.solvers.BaseUnivariateSolver
Solve for a zero in the vicinity of startValue.
solve(int, FUNC, double, double, AllowedSolution) - Method in interface org.apache.commons.math3.analysis.solvers.BracketedUnivariateSolver
Solve for a zero in the given interval.
solve(int, FUNC, double, double, double, AllowedSolution) - Method in interface org.apache.commons.math3.analysis.solvers.BracketedUnivariateSolver
Solve for a zero in the given interval, start at startValue.
solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Solve for a zero in the given interval.
solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class org.apache.commons.math3.analysis.solvers.BracketingNthOrderBrentSolver
Solve for a zero in the given interval, start at startValue.
solve(int, UnivariateDifferentiableFunction, double, double) - Method in class org.apache.commons.math3.analysis.solvers.NewtonRaphsonSolver
Find a zero near the midpoint of min and max.
solve(int, DifferentiableUnivariateFunction, double, double) - Method in class org.apache.commons.math3.analysis.solvers.NewtonSolver
Deprecated. Find a zero near the midpoint of min and max.
solve(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Convenience method to find a zero of a univariate real function.
solve(UnivariateFunction, double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Convenience method to find a zero of a univariate real function.
solve(int, UnivariateDfpFunction, Dfp, Dfp, AllowedSolution) - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Solve for a zero in the given interval.
solve(int, UnivariateDfpFunction, Dfp, Dfp, Dfp, AllowedSolution) - Method in class org.apache.commons.math3.dfp.BracketingNthOrderBrentSolverDFP
Solve for a zero in the given interval, start at startValue.
solve(RealVector) - Method in interface org.apache.commons.math3.linear.DecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(RealMatrix) - Method in interface org.apache.commons.math3.linear.DecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldDecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealLinearOperator, RealVector, boolean, double) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solve(RealLinearOperator, RealVector, boolean, double) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns the solution to the system (A - shift · I) · x = b.
solve(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solveAllComplex(double[], double) - Method in class org.apache.commons.math3.analysis.solvers.LaguerreSolver
Find all complex roots for the polynomial with the given coefficients, starting from the given initial value.
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 org.apache.commons.math3.analysis.solvers.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 org.apache.commons.math3.linear.ConjugateGradient
Returns an estimate of the solution to the linear system A · x = b.
solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.IterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.PreconditionedIterativeLinearSolver
Returns an estimate of the solution to the linear system A · x = b.
solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system (A - shift · I) · x = b.
solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.apache.commons.math3.linear.SymmLQ
Returns an estimate of the solution to the linear system A · x = b.
solveInverseCumulativeProbability(double, int, int) - Method in class org.apache.commons.math3.distribution.AbstractIntegerDistribution
This is a utility function used by AbstractIntegerDistribution.inverseCumulativeProbability(double).
solveLowerTriangularSystem(RealMatrix, RealVector) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Solve a system of composed of a Lower Triangular Matrix RealMatrix.
solvePhase1(SimplexTableau) - Method in class org.apache.commons.math3.optim.linear.SimplexSolver
Solves Phase 1 of the Simplex method.
solvePhase1(SimplexTableau) - Method in class org.apache.commons.math3.optimization.linear.SimplexSolver
Deprecated. 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.
SOLVER_DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math3.distribution.AbstractRealDistribution
Default accuracy.
solveUpperTriangularSystem(RealMatrix, RealVector) - Static method in class org.apache.commons.math3.linear.MatrixUtils
Solver a system composed of an Upper Triangular Matrix RealMatrix.
sortingAlgorithm - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
Search index algorithm.
sortInPlace(double[], double[]...) - Static method in class org.apache.commons.math3.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 org.apache.commons.math3.util.MathArrays
Sort an array in place and perform the same reordering of entries on other arrays.
sortVerticies(Vector2D[][], boolean) - Static method in class org.apache.commons.math3.geometry.euclidean.twod.PolygonsSet
Method to sort vertices according to a specific sense : (trigonometric or clockwise)
SP3File - Class in org.orekit.files.sp3
Represents a parsed SP3 orbit file.
SP3File() - Constructor for class org.orekit.files.sp3.SP3File
Create a new SP3 file object.
SP3File.SP3FileType - Enum in org.orekit.files.sp3
File type indicator.
SP3File.SP3OrbitType - Enum in org.orekit.files.sp3
Orbit type indicator.
SP3Parser - Class in org.orekit.files.sp3
A parser for the SP3 orbit file format.
SP3Parser() - Constructor for class org.orekit.files.sp3.SP3Parser
 
SP_IERS2003 - Static variable in class org.orekit.frames.configuration.sp.SPrimeModelFactory
IERS 2003 convention.
SP_IERS2010 - Static variable in class org.orekit.frames.configuration.sp.SPrimeModelFactory
IERS 2010 convention.
Space - Interface in org.apache.commons.math3.geometry
This interface represents a generic space, with affine and vectorial counterparts.
SpacecraftFrame - Class in org.orekit.frames
Deprecated. as of 6.0 replaced by SpacecraftState.toTransform()
SpacecraftFrame(Propagator, String) - Constructor for class org.orekit.frames.SpacecraftFrame
Deprecated. Simple constructor.
spacecraftsMaskingDistance(AbsoluteDate) - 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 org.orekit.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 org.orekit.propagation.SpacecraftState
Build a spacecraft state from orbit only.
SpacecraftState(Orbit, Attitude) - Constructor for class org.orekit.propagation.SpacecraftState
Build a spacecraft state from orbit and a single attitude.
SpacecraftState(Orbit, MassProvider) - Constructor for class org.orekit.propagation.SpacecraftState
Create a new instance from orbit and mass provider.
SpacecraftState(Orbit, Attitude, MassProvider) - Constructor for class org.orekit.propagation.SpacecraftState
Build a spacecraft state from orbit, attitude and mass provider.
SpacecraftState(Orbit, Attitude, Attitude) - Constructor for class org.orekit.propagation.SpacecraftState
Build a spacecraft state from orbit, attitude for forces and events computation.
SpacecraftState(Orbit, Attitude, Attitude, Map<String, double[]>) - Constructor for class org.orekit.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 org.orekit.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 org.orekit.propagation.SpacecraftState
Build a spacecraft state from orbit, attitude 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 org.orekit.propagation.SpacecraftState
Build a spacecraft from an array (a state vector) and an additional states informations map.
SparseFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Deprecated. As of version 3.1, this class is deprecated, for reasons exposed in this JIRA ticket. This class will be removed in version 4.0.
SparseFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Create a matrix with no data.
SparseFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Create a new SparseFieldMatrix with the supplied row and column dimensions.
SparseFieldMatrix(SparseFieldMatrix<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Copy constructor.
SparseFieldMatrix(FieldMatrix<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldMatrix
Deprecated. Generic copy constructor.
SparseFieldVector<T extends FieldElement<T>> - Class in org.apache.commons.math3.linear
Deprecated. As of version 3.1, this class is deprecated, for reasons exposed in this JIRA ticket. This class will be removed in version 4.0.
SparseFieldVector(Field<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Build a 0-length vector.
SparseFieldVector(Field<T>, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Construct a vector of zeroes.
SparseFieldVector(SparseFieldVector<T>, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Build a resized vector, for use with append.
SparseFieldVector(Field<T>, int, int) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Build a vector with known the sparseness (for advanced use only).
SparseFieldVector(Field<T>, T[]) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Create from a Field array.
SparseFieldVector(SparseFieldVector<T>) - Constructor for class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Copy constructor.
sparseIterator() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Create a sparse iterator over the vector, which may omit some entries.
sparseIterator() - Method in class org.apache.commons.math3.linear.RealVector
Deprecated. As of 3.1, this method is deprecated, because its interface is too confusing (see JIRA MATH-875). This method will be completely removed in 4.0.
SparseRealMatrix - Interface in org.apache.commons.math3.linear
Deprecated. As of version 3.1, this class is deprecated, for reasons exposed in this JIRA ticket. This class will be removed in version 4.0.
SparseRealVector - Class in org.apache.commons.math3.linear
Deprecated. As of version 3.1, this class is deprecated, for reasons exposed in this JIRA ticket. This class will be removed in version 4.0.
SparseRealVector() - Constructor for class org.apache.commons.math3.linear.SparseRealVector
Deprecated.  
SpearmansCorrelation - Class in org.apache.commons.math3.stat.correlation
Spearman's rank correlation.
SpearmansCorrelation() - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation without data.
SpearmansCorrelation(RankingAlgorithm) - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation with the given ranking algorithm.
SpearmansCorrelation(RealMatrix) - Constructor for class org.apache.commons.math3.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation from the given data matrix.
SpearmansCorrelation(RealMatrix, RankingAlgorithm) - Constructor for class org.apache.commons.math3.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 org.orekit.utils.Constants
Speed of light: 299792458.0 m/s.
Sphere - Class in org.apache.commons.math3.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 org.apache.commons.math3.geometry.euclidean.threed.Sphere
Build a sphere from its radius and the position of its center
SphericalCap - Class in org.apache.commons.math3.geometry.euclidean.threed
Implements a representation of a spherical cap solid.
SphericalCap(Sphere, Plane) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SphericalCap
Constructor of a SphericalCap using a Sphere and a Plane.
Spheroid - Class in org.apache.commons.math3.geometry.euclidean.threed
This is the Spheroid (also called Revolved Ellipsoid) class.
Spheroid(Vector3D, Vector3D, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Spheroid
This constructor builds a spheroid from its centers position, its revolution axis and its transverse and conjugate radii.
SpinStabilized - Class in org.orekit.attitudes
This class handles a spin stabilized attitude provider.
SpinStabilized(AttitudeLaw, AbsoluteDate, Vector3D, double) - Constructor for class org.orekit.attitudes.SpinStabilized
Creates a new instance.
spline(double[], double[], int, double, double, double[]) - Method in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
spline.
Calculate 2nd derivatives of cubic spline interpolation function adapted from numerical recipes by press et al.
SplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Computes a natural (also known as "free", "unclamped") cubic spline interpolation for the data set.
SplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.SplineInterpolator
 
splint(double[], double[], double[], int, double) - Method in class org.orekit.forces.atmospheres.MSIS2000.NRLMSISE00
splint calculate cubic spline interpolation value adapted from numerical recipes by press et al.
split(DfpField, String) - Static method in class org.apache.commons.math3.dfp.DfpMath
Breaks a string representation up into two dfp's.
split(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
Splits a Dfp into 2 Dfp's such that their sum is equal to the input Dfp.
split(Hyperplane<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
Split the instance in two parts by an hyperplane.
split(Hyperplane<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.SubPlane
Split the instance in two parts by an hyperplane.
split(Hyperplane<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Split the instance in two parts by an hyperplane.
split(Hyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.AbstractSubHyperplane
Split the instance in two parts by an hyperplane.
split(SubHyperplane<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Split a BSP tree by an external sub-hyperplane.
split(Hyperplane<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.SubHyperplane
Split the instance in two parts by an hyperplane.
splitDiv(Dfp[], Dfp[]) - Static method in class org.apache.commons.math3.dfp.DfpMath
Divide two numbers that are split in to two pieces that are meant to be added together.
splitMult(Dfp[], Dfp[]) - Static method in class org.apache.commons.math3.dfp.DfpMath
Multiply two numbers that are split in to two pieces that are meant to be added together.
splitPow(Dfp[], int) - Static method in class org.apache.commons.math3.dfp.DfpMath
Raise a split base to the a power.
SPrimeModel - Interface in org.orekit.frames.configuration.sp
This interface provides the s' correction (used for the following transformation : TIRF -> ITRF).
SPrimeModelFactory - Class in org.orekit.frames.configuration.sp
Factory for predefined models.
sqrt() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Square root.
Sqrt - Class in org.apache.commons.math3.analysis.function
Square-root function.
Sqrt() - Constructor for class org.apache.commons.math3.analysis.function.Sqrt
 
sqrt() - Method in class org.apache.commons.math3.complex.Complex
Compute the square root of this complex number.
sqrt() - Method in class org.apache.commons.math3.dfp.Dfp
Compute the square root.
sqrt() - Method in class org.apache.commons.math3.linear.JacobiPreconditioner
Returns the square root of this diagonal operator.
sqrt() - Method in interface org.apache.commons.math3.RealFieldElement
Square root.
sqrt(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the square root of a number.
sqrt1z() - Method in class org.apache.commons.math3.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.
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.
StableRandomGenerator - Class in org.apache.commons.math3.random
This class provides a stable normalized random generator.
StableRandomGenerator(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.random.StableRandomGenerator
Create a new generator.
STANDARD_SCALE_HEIGHT - Static variable in class fr.cnes.sirius.patrius.assembly.properties.AeroSphereProperty
Atmospheric height scale factor for the exponential model.
StandardDeviation - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the sample standard deviation.
StandardDeviation() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Constructs a StandardDeviation.
StandardDeviation(SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Constructs a StandardDeviation from an external second moment.
StandardDeviation(StandardDeviation) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Copy constructor, creates a new StandardDeviation identical to the original
StandardDeviation(boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.StandardDeviation
Contructs a StandardDeviation with the specified value for the isBiasCorrected property.
StandardDeviation(boolean, SecondMoment) - Constructor for class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.stat.StatUtils
Returns the standard deviation of the entries in the input array, using the precomputed mean value.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int) - Method in interface org.apache.commons.math3.linear.RealVectorChangingVisitor
Start visiting a vector.
start(int, int, int) - Method in interface org.apache.commons.math3.linear.RealVectorPreservingVisitor
Start visiting a vector.
start(double, double[], double) - Method in class org.apache.commons.math3.ode.MultistepIntegrator
Start the integration.
start() - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Deprecated. As of 3.1.
START_END_TRANSITIONS - Static variable in class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
The start and the end point of the laws are computed.
START_TRANSITIONS - Static variable in class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
The start date of the laws are computed.
STATE_SIZE - Static variable in class fr.cnes.sirius.patrius.stela.propagation.StelaDifferentialEquations
Size of the state vector.
stateTab - Variable in class org.orekit.propagation.precomputed.AbstractEphemeris
The SpacecraftStates array, chronologically sorted.
stateVariation - Variable in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
State variation.
StationToSatMutualVisibilityDetector - Class in fr.cnes.sirius.patrius.events.sensor
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.sensor.StationToSatMutualVisibilityDetector
Constructor for the mutual station to spacecraft visibility detector
StationToSatMutualVisibilityDetector(SensorModel, GeometricStationAntenna, AngularCorrection, boolean, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.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.sensor.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.sensor.StationToSatMutualVisibilityDetector
Constructor for the mutual station to spacecraft visibility detector
StationToSatMutualVisibilityDetector(SensorModel, TopocentricFrame, double[][], AngularCorrection, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.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.sensor.StationToSatMutualVisibilityDetector
Constructor for the mutual station to spacecraft visibility detector
StatisticalMultivariateSummary - Interface in org.apache.commons.math3.stat.descriptive
Reporting interface for basic multivariate statistics.
StatisticalSummary - Interface in org.apache.commons.math3.stat.descriptive
Reporting interface for basic univariate statistics.
StatisticalSummaryValues - Class in org.apache.commons.math3.stat.descriptive
Value object representing the results of a univariate statistical summary.
StatisticalSummaryValues(double, double, long, double, double, double) - Constructor for class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
Constructor
StatUtils - Class in org.apache.commons.math3.stat
StatUtils provides static methods for computing statistics based on data stored in double[] arrays.
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, StelaCd, 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, StelaCd, 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, StelaCd, 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.
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.
StelaCd - Class in fr.cnes.sirius.patrius.stela.forces.drag
This class represent a drag coefficient model.
StelaCd(double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaCd
Simple constructor for a constant Cd.
StelaCd(Map<Double, Double>, double, double) - Constructor for class fr.cnes.sirius.patrius.stela.forces.drag.StelaCd
Constructor for a Cd model depending on spacecraft altitude.
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.
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 org.orekit.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 org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Creates a new instance.
StelaForceModel - Interface in fr.cnes.sirius.patrius.stela.forces
This interface represents a force modifying spacecraft motion for a StelaGTOPropagator.
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
StelaLagrangeEquations() - Constructor for class fr.cnes.sirius.patrius.stela.forces.StelaLagrangeEquations
simple constructor
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.
StelaPrecessionNutationModel - Class in org.orekit.frames.configuration.precessionnutation
STELA specific precession/nutation model.
StelaPrecessionNutationModel() - Constructor for class org.orekit.frames.configuration.precessionnutation.StelaPrecessionNutationModel
Public constructor.
StelaSpacecraftFactory - Class in fr.cnes.sirius.patrius.stela
Utility class to build Stela spacecrafts
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, CelestialBody) - 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, CelestialBody, double, double, double) - 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(CelestialBody, int, int, int) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.StelaThirdBodyAttraction
Creates a Stela third body attraction force 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(double, double[]) - Method in class org.apache.commons.math3.ode.events.EventState
Acknowledge the fact the step has been accepted by the integrator.
stepAccepted(SpacecraftState) - Method in class org.orekit.propagation.events.EventState
Acknowledge the fact the step has been accepted by the propagator.
stepCounter - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Step counter for drag computation.
StepFunction - Class in org.apache.commons.math3.analysis.function
Step function.
StepFunction(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.function.StepFunction
Builds a step function from a list of arguments and the corresponding values.
StepHandler - Interface in org.apache.commons.math3.ode.sampling
This interface represents a handler that should be called after each successful step.
stepHandlers - Variable in class org.apache.commons.math3.ode.AbstractIntegrator
Step handler.
StepInterpolator - Interface in org.apache.commons.math3.ode.sampling
This interface represents an interpolator over the last step during an ODE integration.
StepNormalizer - Class in org.apache.commons.math3.ode.sampling
This class wraps an object implementing FixedStepHandler into a StepHandler.
StepNormalizer(double, FixedStepHandler) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
Simple constructor.
StepNormalizer(double, FixedStepHandler, StepNormalizerMode) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
Simple constructor.
StepNormalizer(double, FixedStepHandler, StepNormalizerBounds) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
Simple constructor.
StepNormalizer(double, FixedStepHandler, StepNormalizerMode, StepNormalizerBounds) - Constructor for class org.apache.commons.math3.ode.sampling.StepNormalizer
Simple constructor.
StepNormalizerBounds - Enum in org.apache.commons.math3.ode.sampling
Step normalizer bounds settings.
StepNormalizerMode - Enum in org.apache.commons.math3.ode.sampling
Step normalizer modes.
stepSize - Variable in class org.apache.commons.math3.ode.AbstractIntegrator
Current stepsize.
stepStart - Variable in class org.apache.commons.math3.ode.AbstractIntegrator
Current step start time.
stillAcceptsData() - Method in class fr.cnes.sirius.patrius.signalpropagation.iono.R12Loader
 
stillAcceptsData() - Method in class fr.cnes.sirius.patrius.signalpropagation.iono.USKLoader
 
stillAcceptsData() - Method in class fr.cnes.sirius.patrius.tools.force.validation.PVEphemerisLoader
 
stillAcceptsData() - Method in interface org.orekit.data.DataLoader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.forces.atmospheres.solarActivity.SolarActivityDataReader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.forces.gravity.potential.PotentialCoefficientsReader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.forces.gravity.tides.coefficients.OceanTidesCoefficientsReader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.frames.configuration.eop.BulletinBFilesLoader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.frames.configuration.eop.EOP05C04FilesLoader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.frames.configuration.eop.EOP08C04FilesLoader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.frames.configuration.eop.NoEOP1980HistoryLoader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.frames.configuration.eop.RapidDataAndPredictionColumnsLoader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.frames.configuration.eop.RapidDataAndPredictionXMLLoader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.models.earth.GeoMagneticModelReader
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.propagation.analytical.tle.TLESeries
Check if the loader still accepts new data.
stillAcceptsData() - Method in class org.orekit.utils.InterpolationTableLoader
Check if the loader still accepts new data.
stirlingS2(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Returns the Stirling number of the second kind, "S(n,k)", the number of ways of partitioning an n-element set into k non-empty subsets.
stop() - Method in class org.apache.commons.math3.ode.events.EventState
Check if the integration should be stopped at the end of the current step.
stop() - Method in class org.orekit.propagation.events.EventState
Check if the propagation should be stopped at the end of the current step.
StoppingCondition - Interface in org.apache.commons.math3.genetics
Algorithm used to determine when to stop evolution.
store(PAIR) - Method in class org.apache.commons.math3.optim.BaseMultiStartMultivariateOptimizer
Method that will be called in order to store each found optimum.
store(PointValuePair) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
Method that will be called in order to store each found optimum.
store(PointVectorValuePair) - Method in class org.apache.commons.math3.optim.nonlinear.vector.MultiStartMultivariateVectorOptimizer
Method that will be called in order to store each found optimum.
storeDate(AbsoluteDate) - Method in class org.orekit.propagation.sampling.BasicStepInterpolator
Store the current step date.
StorelessCovariance - Class in org.apache.commons.math3.stat.correlation
Covariance implementation that does not require input data to be stored in memory.
StorelessCovariance(int) - Constructor for class org.apache.commons.math3.stat.correlation.StorelessCovariance
Create a bias corrected covariance matrix with a given dimension.
StorelessCovariance(int, boolean) - Constructor for class org.apache.commons.math3.stat.correlation.StorelessCovariance
Create a covariance matrix with a given number of rows and columns and the indicated bias correction.
StorelessUnivariateStatistic - Interface in org.apache.commons.math3.stat.descriptive
Extends the definition of UnivariateStatistic with StorelessUnivariateStatistic.increment(double) and StorelessUnivariateStatistic.incrementAll(double[]) methods for adding values and updating internal state.
storeSC(SpacecraftState, SpacecraftState) - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaBasicInterpolator
Store the current dates and spacecraft states.
storeState(double, double[], boolean) - Method in class org.apache.commons.math3.ode.events.EventState
Store event state with provided time and state.
storeState(SpacecraftState) - Method in class org.orekit.propagation.events.EventState
Reinitialize event state with provided time and state.
storeTime(double) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Store the current step time.
strictlyNegative() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is strictly less than 0.
strictlyPositive() - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is strictly greater than 0.
subAndCheck(int, int) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Subtract two integers, checking for overflow.
subAndCheck(long, long) - Static method in class org.apache.commons.math3.util.ArithmeticUtils
Subtract two long integers, checking for overflow.
SubHyperplane<S extends Space> - Interface in org.apache.commons.math3.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 org.apache.commons.math3.geometry.partitioning
Class holding the results of the split method.
SubHyperplane.SplitSubHyperplane(SubHyperplane<U>, SubHyperplane<U>) - Constructor for class org.apache.commons.math3.geometry.partitioning.SubHyperplane.SplitSubHyperplane
Build a SplitSubHyperplane from its parts.
SubLine - Class in org.apache.commons.math3.geometry.euclidean.threed
This class represents a subset of a Line.
SubLine(Line, IntervalsSet) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Simple constructor.
SubLine(Vector3D, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Create a sub-line from two endpoints.
SubLine(Segment) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubLine
Create a sub-line from a segment.
SubLine - Class in org.apache.commons.math3.geometry.euclidean.twod
This class represents a sub-hyperplane for Line.
SubLine(Hyperplane<Euclidean2D>, Region<Euclidean1D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Simple constructor.
SubLine(Vector2D, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Create a sub-line from two endpoints.
SubLine(Segment) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.SubLine
Create a sub-line from a segment.
SubOrientedPoint - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents sub-hyperplane for OrientedPoint.
SubOrientedPoint(Hyperplane<Euclidean1D>, Region<Euclidean1D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.SubOrientedPoint
Simple constructor.
SubPlane - Class in org.apache.commons.math3.geometry.euclidean.threed
This class represents a sub-hyperplane for Plane.
SubPlane(Hyperplane<Euclidean3D>, Region<Euclidean2D>) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.SubPlane
Simple constructor.
substituteMostRecentElement(double) - Method in class org.apache.commons.math3.util.ResizableDoubleArray
Substitutes value for the most recently added value.
subtract(double) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'-' operator.
subtract(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
'-' operator.
subtract(double[], int, double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Perform subtraction of two derivative structures.
Subtract - Class in org.apache.commons.math3.analysis.function
Subtract the second operand from the first.
Subtract() - Constructor for class org.apache.commons.math3.analysis.function.Subtract
 
subtract(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Subtract a polynomial from the instance.
subtract(TrigonometricPolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Subtract a polynomial to the current polynomial :
subtract(TrigonometricPolynomialPrimitive) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Subtract two TrigonometricPolynomialPrimitive
subtract(PolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Subtract a PolynomialFunction
subtract(TrigonometricPolynomialFunction) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Subtract a TrigonometricPolynomialFunction
subtract(Complex) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this - subtrahend).
subtract(double) - Method in class org.apache.commons.math3.complex.Complex
Returns a Complex whose value is (this - subtrahend).
subtract(Quaternion, Quaternion) - Static method in class org.apache.commons.math3.complex.Quaternion
Subtracts two quaternions.
subtract(Quaternion) - Method in class org.apache.commons.math3.complex.Quaternion
Subtracts a quaternion from the instance.
subtract(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Subtract x from this.
subtract(T) - Method in interface org.apache.commons.math3.FieldElement
Compute this - a.
subtract(BigInteger) - Method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.fraction.Fraction
Subtract an integer from the fraction.
subtract(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Subtract a vector from the instance.
subtract(double, Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Subtract a scaled vector from the instance.
subtract(FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a vector from the instance.
subtract(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a vector from the instance.
subtract(T, FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a scaled vector from the instance.
subtract(T, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a scaled vector from the instance.
subtract(double, FieldVector3D<T>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a scaled vector from the instance.
subtract(double, Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Subtract a scaled vector from the instance.
subtract(Matrix3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Computes the subtraction of a Matrix3D to this one
subtract(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Subtract a vector from the instance.
subtract(double, Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Subtract a scaled vector from the instance.
subtract(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Subtract a vector from the instance.
subtract(double, Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Subtract a scaled vector from the instance.
subtract(Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Subtract a vector from the instance.
subtract(double, Vector<S>) - Method in interface org.apache.commons.math3.geometry.Vector
Subtract a scaled vector from the instance.
subtract(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Subtract m from this matrix.
subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns this minus m.
subtract(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Subtract m from this matrix.
subtract(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Returns this minus m.
subtract(FieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute this minus v.
subtract(ArrayFieldVector<T>) - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Compute this minus v.
subtract(RealVector) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Subtract v from this vector.
subtract(FieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Subtract m from this matrix.
subtract(BlockFieldMatrix<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Compute this - m.
subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns this minus m.
subtract(BlockRealMatrix) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Subtract m from this matrix.
subtract(DiagonalMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns this minus m.
subtract(SymmetricMatrix) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Returns this minus m.
subtract(FieldMatrix<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Subtract m from this matrix.
subtract(FieldVector<T>) - Method in interface org.apache.commons.math3.linear.FieldVector
Compute this minus v.
subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Returns this minus m.
subtract(OpenMapRealMatrix) - Method in class org.apache.commons.math3.linear.OpenMapRealMatrix
Deprecated. Subtract m from this matrix.
subtract(OpenMapRealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Optimized method to subtract OpenMapRealVectors.
subtract(RealVector) - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Subtract v from this vector.
subtract(RealMatrix) - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns this minus m.
subtract(RealVector) - Method in class org.apache.commons.math3.linear.RealVector
Subtract v from this vector.
subtract(SparseFieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Optimized method to compute this minus v.
subtract(FieldVector<T>) - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Compute this minus v.
subtract(SymmetricMatrix) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Compute this minus m.
subtract(DiagonalMatrix) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Compute this minus m.
subtract(RealMatrix) - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns this minus m.
subtract(double) - Method in interface org.apache.commons.math3.RealFieldElement
'-' operator.
subtract(BigReal) - Method in class org.apache.commons.math3.util.BigReal
Compute this - a.
subtract(Decimal64) - Method in class org.apache.commons.math3.util.Decimal64
Compute this - a.
subtractOffset(AngularCoordinates, boolean) - Method in class org.orekit.utils.AngularCoordinates
Subtract an offset from the instance.
subtractOffset(AngularCoordinates) - Method in class org.orekit.utils.AngularCoordinates
Subtract an offset from the instance.
subtractOffset(AngularCoordinates) - Method in class org.orekit.utils.TimeStampedAngularCoordinates
Subtract an offset from the instance.
subtractOffset(AngularCoordinates, boolean) - Method in class org.orekit.utils.TimeStampedAngularCoordinates
Subtract an offset from the instance.
sum(Screw, Screw) - Static method in class org.apache.commons.math3.geometry.euclidean.threed.Screw
Calculate the sum of this and screw, expressed in this objects origin.
sum(Screw) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Screw
Calculate the sum of this and screw, expressed in this objects origin.
Sum - Class in org.apache.commons.math3.stat.descriptive.summary
Returns the sum of the available values.
Sum() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Sum
Create a Sum instance
Sum(Sum) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.Sum
Copy constructor, creates a new Sum identical to the original
sum(double[]) - Static method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.orekit.wrenches.Wrench
Sum of two wrenches.
sumDifference(double[], double[]) - Static method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.apache.commons.math3.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.
SummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
Computes summary statistics for a stream of data values added using the addValue method.
SummaryStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Construct a SummaryStatistics instance
SummaryStatistics(SummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.SummaryStatistics
A copy constructor.
SumOfLogs - Class in org.apache.commons.math3.stat.descriptive.summary
Returns the sum of the natural logs for this collection of values.
SumOfLogs() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Create a SumOfLogs instance
SumOfLogs(SumOfLogs) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfLogs
Copy constructor, creates a new SumOfLogs identical to the original
SumOfSquares - Class in org.apache.commons.math3.stat.descriptive.summary
Returns the sum of the squares of the available values.
SumOfSquares() - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Create a SumOfSquares instance
SumOfSquares(SumOfSquares) - Constructor for class org.apache.commons.math3.stat.descriptive.summary.SumOfSquares
Copy constructor, creates a new SumOfSquares identical to the original
sumSq(double[]) - Static method in class org.apache.commons.math3.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 org.apache.commons.math3.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 org.orekit.bodies.CelestialBodyFactory
Predefined name for Sun.
SUN_RADIUS - Static variable in interface org.orekit.utils.Constants
Sun radius: 695500000 m.
SunPointing - Class in org.orekit.attitudes
This class implements a Sun pointing attitude law.
SunPointing(Vector3D, Vector3D) - Constructor for class org.orekit.attitudes.SunPointing
Constructor of the sun pointing attitude law.
SunPointing(CelestialBody, Vector3D, Vector3D) - Constructor for class org.orekit.attitudes.SunPointing
Constructor of the sun pointing attitude law.
supplementaryAngle(double, AngleInterval) - Static method in class fr.cnes.sirius.patrius.utils.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 org.orekit.parameter.IJacobiansParameterizable
Check if a jacobian parameter is supported.
supportsJacobianParameter(Parameter) - Method in class org.orekit.parameter.JacobiansParameterizable
Check if a jacobian parameter is supported.
supportsParameter(Parameter) - Method in interface org.orekit.parameter.IParameterizable
Check if a parameter is supported.
supportsParameter(Parameter) - Method in class org.orekit.parameter.ParamDiffFunction
Check if a parameter is supported.
supportsParameter(Parameter) - Method in class org.orekit.parameter.Parameterizable
Check if a parameter is supported.
supportsTimeTransform() - Method in class org.orekit.models.earth.GeoMagneticField
Indicates whether this model supports time transformation or not.
sxpInitialize() - Method in class org.orekit.propagation.analytical.tle.TLEPropagator
Initialization proper to each propagator (SGP or SDP).
sxpPropagate(double) - Method in class org.orekit.propagation.analytical.tle.TLEPropagator
Propagation proper to each propagator (SGP or SDP).
SymmetricMatrix - Class in org.apache.commons.math3.linear
Implementation of a symmetric matrix.
SymmetricMatrix(SymmetricMatrix.SYMMETRIC, int, int) - Constructor for class org.apache.commons.math3.linear.SymmetricMatrix
Creates a matrix with the supplied dimensions.
SymmetricMatrix(SymmetricMatrix.SYMMETRIC, int, int, double[], boolean) - Constructor for class org.apache.commons.math3.linear.SymmetricMatrix
Creates a matrix given the supplied dimensions and data array.
SymmetricMatrix(SymmetricMatrix.SYMMETRIC, int, int, double[]) - Constructor for class org.apache.commons.math3.linear.SymmetricMatrix
Creates a matrix given the supplied dimensions and data array.
SymmetricMatrix(SymmetricMatrix.SYMMETRIC, int, int, double[][]) - Constructor for class org.apache.commons.math3.linear.SymmetricMatrix
Creates a matrix given the supplied dimensions and data array 2D.
SymmetricMatrix(SymmetricMatrix.SYMMETRIC, int, int, RealMatrix) - Constructor for class org.apache.commons.math3.linear.SymmetricMatrix
Creates a symmetric matrix using a real matrix.
SymmetricMatrix.SYMMETRIC - Enum in org.apache.commons.math3.linear
Enumerate to fill in a symmetric matrix only by its lower/upper part.
symmetricMatrixOperation(double, SymmetricMatrix, RealMatrix, double, RealMatrix) - Static method in class org.apache.commons.math3.linear.SymmetricMatrix
Performs the matrix-matrix operations C := alpha*A*B + beta*C where alpha and beta are scalars, A is a symmetric matrix and B and C are n by n matrices.
SymmLQ - Class in org.apache.commons.math3.linear
Implementation of the SYMMLQ iterative linear solver proposed by Paige and Saunders (1975).
SymmLQ(int, double, boolean) - Constructor for class org.apache.commons.math3.linear.SymmLQ
Creates a new instance of this class, with default stopping criterion.
SymmLQ(IterationManager, double, boolean) - Constructor for class org.apache.commons.math3.linear.SymmLQ
Creates a new instance of this class, with default stopping criterion and custom iteration manager.
SynchronizedDescriptiveStatistics - Class in org.apache.commons.math3.stat.descriptive
Implementation of DescriptiveStatistics that is safe to use in a multithreaded environment.
SynchronizedDescriptiveStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Construct an instance with infinite window
SynchronizedDescriptiveStatistics(int) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Construct an instance with finite window
SynchronizedDescriptiveStatistics(SynchronizedDescriptiveStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
A copy constructor.
SynchronizedMultivariateSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
Implementation of MultivariateSummaryStatistics that is safe to use in a multithreaded environment.
SynchronizedMultivariateSummaryStatistics(int, boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Construct a SynchronizedMultivariateSummaryStatistics instance
SynchronizedRandomGenerator - Class in org.apache.commons.math3.random
Any RandomGenerator implementation can be thread-safe if it is used through an instance of this class.
SynchronizedRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math3.random.SynchronizedRandomGenerator
Creates a synchronized wrapper for the given RandomGenerator instance.
SynchronizedSummaryStatistics - Class in org.apache.commons.math3.stat.descriptive
Implementation of SummaryStatistics that is safe to use in a multithreaded environment.
SynchronizedSummaryStatistics() - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Construct a SynchronizedSummaryStatistics instance
SynchronizedSummaryStatistics(SynchronizedSummaryStatistics) - Constructor for class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
A copy constructor.

T

t(double, double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
t(double, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
t(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
t(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
t(double, double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a t statistic given observed values and a comparison constant.
t(double, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a t statistic to use in comparing the mean of the dataset described by sampleStats to mu.
t(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a 2-sample t statistic, without the hypothesis of equal subpopulation variances.
t(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes a 2-sample t statistic , comparing the means of the datasets described by two StatisticalSummary instances, without the assumption of equal subpopulation variances.
t(double, double, double, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes t test statistic for 1-sample t-test.
t(double, double, double, double, double, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes t test statistic for 2-sample t-test.
t2cof - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
3/2 * C1.
tab - Variable in class org.apache.commons.math3.utils.AbstractSearchIndex
The values in with the search algorithm will be executed.
TabulatedAttitude - Class in org.orekit.attitudes
This class implements the tabulated attitude leg.
TabulatedAttitude(Collection<Attitude>, RotationInterpolator) - Constructor for class org.orekit.attitudes.TabulatedAttitude
Deprecated. since 3.1 (use TabulatedAttitude.TabulatedAttitude(List) or TabulatedAttitude.TabulatedAttitude(List, int)
TabulatedAttitude(List<Attitude>) - Constructor for class org.orekit.attitudes.TabulatedAttitude
Constructor with default number N of points used for interpolation.
TabulatedAttitude(List<Attitude>, int) - Constructor for class org.orekit.attitudes.TabulatedAttitude
Constructor with number of points used for interpolation
TAIScale - Class in org.orekit.time
International Atomic Time.
tan() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Tangent operation.
tan(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute tangent of a derivative structure.
Tan - Class in org.apache.commons.math3.analysis.function
Tangent function.
Tan() - Constructor for class org.apache.commons.math3.analysis.function.Tan
 
tan() - Method in class org.apache.commons.math3.complex.Complex
Compute the tangent of this complex number.
tan(Dfp) - Static method in class org.apache.commons.math3.dfp.DfpMath
computes the tangent of the argument.
tan() - Method in interface org.apache.commons.math3.RealFieldElement
Tangent operation.
tan(double) - Static method in class org.apache.commons.math3.util.FastMath
Tangent function.
tanh() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Hyperbolic tangent operation.
tanh(double[], int, double[], int) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Compute hyperbolic tangent of a derivative structure.
Tanh - Class in org.apache.commons.math3.analysis.function
Hyperbolic tangent function.
Tanh() - Constructor for class org.apache.commons.math3.analysis.function.Tanh
 
tanh() - Method in class org.apache.commons.math3.complex.Complex
Compute the hyperbolic tangent of this complex number.
tanh() - Method in interface org.apache.commons.math3.RealFieldElement
Hyperbolic tangent operation.
tanh(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute the hyperbolic tangent of a number.
Target - Class in org.apache.commons.math3.optim.nonlinear.vector
Target of the optimization procedure.
Target(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.Target
 
Target - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
Target(double[]) - Constructor for class org.apache.commons.math3.optimization.Target
Deprecated.  
TargetGroundPointing - Class in org.orekit.attitudes
This class handles target pointing attitude provider; while the class TargetPointing does not guarantee the target point belongs to the body surface, this class always provides a ground point target.
TargetGroundPointing(BodyShape, Vector3D) - Constructor for class org.orekit.attitudes.TargetGroundPointing
Creates a new instance from body shape and target expressed in cartesian coordinates.
TargetGroundPointing(BodyShape, GeodeticPoint) - Constructor for class org.orekit.attitudes.TargetGroundPointing
Creates a new instance from body shape and target expressed in geodetic coordinates.
TargetInFieldOfViewDetector - Class in fr.cnes.sirius.patrius.events.sensor
 
TargetInFieldOfViewDetector(Assembly, String, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
Constructor for the "main target in field of view" detector
TargetInFieldOfViewDetector(Assembly, String, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
Constructor for the "main target in field of view" detector
TargetInFieldOfViewDetector(SensorModel, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
Constructor for the "main target in field of view" detector
TargetInFieldOfViewDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
Constructor for the "main target in field of view" detector
TargetInFieldOfViewDetector(SensorModel, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.TargetInFieldOfViewDetector
Constructor for the "main target in field of view" detector
TargetPointing - Class in org.orekit.attitudes
This class handles target pointing attitude provider.
TargetPointing(Frame, Vector3D) - Constructor for class org.orekit.attitudes.TargetPointing
Creates a new instance from body frame and target expressed in cartesian coordinates.
TargetPointing(GeodeticPoint, BodyShape) - Constructor for class org.orekit.attitudes.TargetPointing
Creates a new instance from body shape and target expressed in geodetic coordinates.
taylor(double...) - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Evaluate Taylor expansion a derivative structure.
taylor(double[], int, double...) - Method in class org.apache.commons.math3.analysis.differentiation.DSCompiler
Evaluate Taylor expansion of a derivative structure.
TCBScale - Class in org.orekit.time
Barycentric Coordinate Time.
TCGScale - Class in org.orekit.time
Geocentric Coordinate Time.
tDate - Variable in class org.orekit.utils.AbstractBoundedPVProvider
Dates table
TDBScale - Class in org.orekit.time
Barycentric Dynamic Time.
TDistribution - Class in org.apache.commons.math3.distribution
Implementation of Student's t-distribution.
TDistribution(double) - Constructor for class org.apache.commons.math3.distribution.TDistribution
Create a t distribution using the given degrees of freedom.
TDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.TDistribution
Create a t distribution using the given degrees of freedom and the specified inverse cumulative probability absolute accuracy.
TDistribution(RandomGenerator, double, double) - Constructor for class org.apache.commons.math3.distribution.TDistribution
Creates a t distribution.
TEMEProvider - Class in org.orekit.frames.transformations
True Equator Mean Equinox Frame.
TEMEProvider() - Constructor for class org.orekit.frames.transformations.TEMEProvider
Simple constructor.
TempDirectory - Class in fr.cnes.sirius.validate.files
This class offers a temporary directory (complete name) to write results in output files
TEN_POINT_FIVE - Static variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Constant 10.5
terminationPerformed(IterationEvent) - Method in interface org.apache.commons.math3.util.IterationListener
Invoked after completion of the operations which occur after breaking out of the main iteration loop.
TerrestrialTides - Class in org.orekit.forces.gravity.tides
This class implements the perturbating force due to terrestrial tides (deformation due to third body attraction on an aneslatic crust, ellipticity correction, frequency correction).
TerrestrialTides(Frame, double, double, List<CelestialBody>, boolean, boolean, boolean, ITerrestrialTidesDataProvider) - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTides
Creates a new instance.
TerrestrialTides(Frame, double, double, List<CelestialBody>, boolean, boolean, boolean, ITerrestrialTidesDataProvider, boolean) - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTides
Creates a new instance.
TerrestrialTides(Frame, Parameter, Parameter, List<CelestialBody>, boolean, boolean, boolean, ITerrestrialTidesDataProvider) - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTides
Creates a new instance using Parameter.
TerrestrialTides(Frame, Parameter, Parameter, List<CelestialBody>, boolean, boolean, boolean, ITerrestrialTidesDataProvider, boolean) - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTides
Creates a new instance using Parameter.
TerrestrialTides(Frame, double, double) - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTides
Creates a new instance.
TerrestrialTides(Frame, double, double, boolean) - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTides
Creates a new instance.
TerrestrialTides(Frame, Parameter, Parameter) - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTides
Creates a new instance.
TerrestrialTides(Frame, Parameter, Parameter, boolean) - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTides
Creates a new instance.
TerrestrialTidesDataProvider - Class in org.orekit.forces.gravity.tides
Terrestrial tides parameters given by the IERS 2003 standard.
TerrestrialTidesDataProvider() - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTidesDataProvider
Simple constructor.
TerrestrialTidesDataProvider(TidesStandards.TidesStandard) - Constructor for class org.orekit.forces.gravity.tides.TerrestrialTidesDataProvider
Simple constructor.
tesseralComputed - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaDifferentialEquations
Required for step computation of the tesseral quads
TesseralQuad - Class in fr.cnes.sirius.patrius.stela.forces.gravity
Tesseral harmonics quad (n, m, p, q) and related data.
TesseralQuad(PotentialCoefficientsProvider, int, int, int, int, Orbit) - Constructor for class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
Constructor.
test(double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
This method is used by evaluate(double[], int, int) methods to verify that the input parameters designate a subarray of positive length.
test(double[], int, int, boolean) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
This method is used by evaluate(double[], int, int) methods to verify that the input parameters designate a subarray of positive length.
test(double[], double[], int, int) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
This method is used by evaluate(double[], double[], int, int) methods to verify that the begin and length parameters designate a subarray of positive length and the weights are all non-negative, non-NaN, finite, and not all zero.
test(double[], double[], int, int, boolean) - Method in class org.apache.commons.math3.stat.descriptive.AbstractUnivariateStatistic
This method is used by evaluate(double[], double[], int, int) methods to verify that the begin and length parameters designate a subarray of positive length and the weights are all non-negative, non-NaN, finite, and not all zero.
TestUtils - Class in org.apache.commons.math3.stat.inference
A collection of static methods to create inference test instances or to perform inference tests.
theta2 - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
cos io squared.
ThirdBodyAttraction - Class in org.orekit.forces.gravity
Third body attraction force model.
ThirdBodyAttraction(CelestialBody) - Constructor for class org.orekit.forces.gravity.ThirdBodyAttraction
Simple constructor.
ThirdBodyAttraction(CelestialBody, boolean) - Constructor for class org.orekit.forces.gravity.ThirdBodyAttraction
Simple constructor.
THIRTY_SIX - Static variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Constant 36
THREE_FIFTHS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "3/5".
THREE_FIFTHS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "3/5".
THREE_QUARTERS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "3/4".
THREE_QUARTERS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "3/4".
ThreeBodiesAngleDetector - Class in org.orekit.propagation.events
Detects when the angle between three bodies is equal to a predetermined value.
ThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, PVCoordinatesProvider, double) - Constructor for class org.orekit.propagation.events.ThreeBodiesAngleDetector
Build a new three bodies angle detector.
ThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, PVCoordinatesProvider, double, double, double) - Constructor for class org.orekit.propagation.events.ThreeBodiesAngleDetector
Build a new three bodies angle detector with complimentary parameters.
ThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, PVCoordinatesProvider, double, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ThreeBodiesAngleDetector
Build a new three bodies angle detector with complimentary parameters.
ThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ThreeBodiesAngleDetector.BodyOrder, double) - Constructor for class org.orekit.propagation.events.ThreeBodiesAngleDetector
Build a new three bodies angle detector with a position among the parameters.
ThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ThreeBodiesAngleDetector.BodyOrder, double, double, double) - Constructor for class org.orekit.propagation.events.ThreeBodiesAngleDetector
Build a new three bodies angle detector with complimentary parameters.
ThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ThreeBodiesAngleDetector.BodyOrder, double, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ThreeBodiesAngleDetector
Build a new three bodies angle detector with complimentary parameters.
ThreeBodiesAngleDetector(PVCoordinatesProvider, PVCoordinatesProvider, ThreeBodiesAngleDetector.BodyOrder, double, double, double, EventDetector.Action, boolean) - Constructor for class org.orekit.propagation.events.ThreeBodiesAngleDetector
Build a new three bodies angle detector with complimentary parameters.
ThreeBodiesAngleDetector(String, String, String, double, double, double, EventDetector.Action) - Constructor for class org.orekit.propagation.events.ThreeBodiesAngleDetector
Build a new three bodies angle detector.
ThreeBodiesAngleDetector.BodyOrder - Enum in org.orekit.propagation.events
Bodies order type.
threeDMatrixVectorMultiply(double[][][], double[]) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Multiply an automatically-generated-3-dimensional matrix with a vector.
Automatically generated 3D matrices have their rows and wideness inverted.
ThreeEighthesIntegrator - Class in org.apache.commons.math3.ode.nonstiff
This class implements the 3/8 fourth order Runge-Kutta integrator for Ordinary Differential Equations.
ThreeEighthesIntegrator(double) - Constructor for class org.apache.commons.math3.ode.nonstiff.ThreeEighthesIntegrator
Simple constructor.
ThresholdsData - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class contains the information on the margins of the deviations with regard to a set of thresholds.
ThresholdsData(ArrayList<ArrayList<Double>>) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.ThresholdsData
Instantiates a new ThresholdsData object, using the constructor from Data.
THRUST - Static variable in class org.orekit.forces.maneuvers.ConstantThrustManeuver
Parameter name for thrust.
TidalCorrection - Class in org.orekit.frames.configuration.tides
This class represents a Pole, UT1-UTC and length of day correction set for a given date.
TidalCorrection(AbsoluteDate, PoleCorrection, double, double) - Constructor for class org.orekit.frames.configuration.tides.TidalCorrection
 
TidalCorrectionGenerator - Class in org.orekit.frames.configuration.tides
Tidal corrections generator for the TimeStampedCache.
TidalCorrectionGenerator(TidalCorrectionModel, int, double) - Constructor for class org.orekit.frames.configuration.tides.TidalCorrectionGenerator
Simple constructor.
TidalCorrectionModel - Interface in org.orekit.frames.configuration.tides
This interface provides the pole corrections as well as the ut1-utc corrections due to tidal effects.
TidalCorrectionModelFactory - Class in org.orekit.frames.configuration.tides
Factory for predefined models.
TIDE_IERS2003_DIRECT - Static variable in class org.orekit.frames.configuration.tides.TidalCorrectionModelFactory
IERS 2003 without interpolation.
TIDE_IERS2003_INTERPOLATED - Static variable in class org.orekit.frames.configuration.tides.TidalCorrectionModelFactory
IERS 2003 with interpolation.
TIDE_IERS2010_DIRECT - Static variable in class org.orekit.frames.configuration.tides.TidalCorrectionModelFactory
IERS 2010 without interpolation.
TIDE_IERS2010_INTERPOLATED - Static variable in class org.orekit.frames.configuration.tides.TidalCorrectionModelFactory
IERS 2010 with interpolation.
TidesStandards - Class in org.orekit.forces.gravity.tides
Tides standards
TidesStandards() - Constructor for class org.orekit.forces.gravity.tides.TidesStandards
 
TidesStandards.TidesStandard - Enum in org.orekit.forces.gravity.tides
Tides standard enum
TidesToolbox - Class in org.orekit.forces.gravity.tides
Tides toolbox
TiesStrategy - Enum in org.apache.commons.math3.stat.ranking
Strategies for handling tied values in rank transformations.
TimeComponents - Class in org.orekit.time
Class representing a time within the day broken up as hour, minute and second components.
TimeComponents(int, int, double) - Constructor for class org.orekit.time.TimeComponents
Build a time from its clock elements.
TimeComponents(double) - Constructor for class org.orekit.time.TimeComponents
Build a time from the second number within the day.
TimeComponents(int, double) - Constructor for class org.orekit.time.TimeComponents
Build a time from the second number within the day.
TimeDerivativeData - Class in fr.cnes.sirius.patrius.stela.propagation.data
Class for data resulting from STELA differential equation system.
TimeDerivativeData(Orbit, double[], double[][], Map<StelaForceModel, double[]>, Map<StelaForceModel, double[][]>) - Constructor for class fr.cnes.sirius.patrius.stela.propagation.data.TimeDerivativeData
Constructor.
TimeDerivativesEquations - Interface in org.orekit.propagation.numerical
Interface summing up the contribution of several forces into orbit and mass derivatives.
TimeFilter - Class in fr.cnes.sirius.patrius.events.postprocessing
 
TimeFilter(AbsoluteDateInterval, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.TimeFilter
Build an instance of TimeFilter from a time interval.
TimeFilter(String, AbsoluteDateInterval, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.TimeFilter
Build an instance of TimeFilter from a time interval.
TimeFilter(List<String>, AbsoluteDateInterval, boolean) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.TimeFilter
Build an instance of TimeFilter from a time interval.
TimeInterpolable<T extends TimeInterpolable<T>> - Interface in org.orekit.time
This interface represents objects that can be interpolated in time.
Timeline - Class in fr.cnes.sirius.patrius.events.postprocessing
 
Timeline(CodedEventsLogger, AbsoluteDateInterval) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.Timeline
Builds an instance of the timeline from a CodedEventsLogger, generating the list of detected events and the list of corresponding phenomena.
These events and phenomena are the output of a propagation with events detector; the coherence between events and phenomena should be guaranteed by the detection process during propagation.
Timeline(Timeline) - Constructor for class fr.cnes.sirius.patrius.events.postprocessing.Timeline
Builds an instance of the Timeline from another Timeline.
TimeScale - Interface in org.orekit.time
Interface for time scales.
TimeScalesFactory - Class in org.orekit.time
Factory for predefined time scales.
timeScalesOffset(TimeScale, TimeScale) - Method in class org.orekit.time.AbsoluteDate
Compute the offset between two time scales at the current instant.
TimeShiftable<T extends TimeShiftable<T>> - Interface in org.orekit.time
This interface represents objects that can be shifted in time.
TimeStamped - Interface in org.orekit.time
This interface represents objects that have a AbsoluteDate date attached to them.
TimeStampedAngularCoordinates - Class in org.orekit.utils
time-stamped version of AngularCoordinates.
TimeStampedAngularCoordinates(AbsoluteDate, Rotation, Vector3D, Vector3D) - Constructor for class org.orekit.utils.TimeStampedAngularCoordinates
Builds a rotation/rotation rate pair.
TimeStampedAngularCoordinates(AbsoluteDate, PVCoordinates, PVCoordinates, PVCoordinates, PVCoordinates, double) - Constructor for class org.orekit.utils.TimeStampedAngularCoordinates
Build the rotation that transforms a pair of pv coordinates into another pair.
TimeStampedAngularCoordinates(AbsoluteDate, PVCoordinates, PVCoordinates, PVCoordinates, PVCoordinates, double, boolean) - Constructor for class org.orekit.utils.TimeStampedAngularCoordinates
Build the rotation that transforms a pair of pv coordinates into another pair.
TimeStampedCache<T extends TimeStamped> - Class in org.orekit.utils
Generic thread-safe cache for time-stamped data.
TimeStampedCache(int, int, double, double, TimeStampedGenerator<T>, Class<T>) - Constructor for class org.orekit.utils.TimeStampedCache
Simple constructor.
TimeStampedCacheException - Exception in org.orekit.errors
This class is the base class for all specific exceptions thrown by during the TimeStampedCache.
TimeStampedCacheException(Localizable, Object...) - Constructor for exception org.orekit.errors.TimeStampedCacheException
Simple constructor.
TimeStampedCacheException(Throwable, Localizable, Object...) - Constructor for exception org.orekit.errors.TimeStampedCacheException
Simple constructor.
TimeStampedCacheException(OrekitException) - Constructor for exception org.orekit.errors.TimeStampedCacheException
Simple constructor.
TimeStampedCacheException(ExceptionContextProvider) - Constructor for exception org.orekit.errors.TimeStampedCacheException
Simple constructor.
TimeStampedGenerator<T extends TimeStamped> - Interface in org.orekit.utils
Generator to use for creating entries in time stamped caches.
TimeStampedPVCoordinates - Class in org.orekit.utils
time-stamped version of PVCoordinates.
TimeStampedPVCoordinates(AbsoluteDate, Vector3D, Vector3D, Vector3D) - Constructor for class org.orekit.utils.TimeStampedPVCoordinates
Builds a TimeStampedPVCoordinates triplet.
TimeStampedPVCoordinates(AbsoluteDate, Vector3D, Vector3D) - Constructor for class org.orekit.utils.TimeStampedPVCoordinates
Build from position and velocity.
TimeStampedPVCoordinates(AbsoluteDate, PVCoordinates) - Constructor for class org.orekit.utils.TimeStampedPVCoordinates
Build from position velocity acceleration coordinates.
TimeStampedPVCoordinates(AbsoluteDate, double, PVCoordinates) - Constructor for class org.orekit.utils.TimeStampedPVCoordinates
Multiplicative constructor
TimeStampedPVCoordinates(AbsoluteDate, PVCoordinates, PVCoordinates) - Constructor for class org.orekit.utils.TimeStampedPVCoordinates
Subtractive constructor
TimeStampedPVCoordinates(AbsoluteDate, double, PVCoordinates, double, PVCoordinates) - Constructor for class org.orekit.utils.TimeStampedPVCoordinates
Linear constructor
TimeStampedPVCoordinates(AbsoluteDate, double, PVCoordinates, double, PVCoordinates, double, PVCoordinates) - Constructor for class org.orekit.utils.TimeStampedPVCoordinates
Linear constructor
TimeStampedPVCoordinates(AbsoluteDate, double, PVCoordinates, double, PVCoordinates, double, PVCoordinates, double, PVCoordinates) - Constructor for class org.orekit.utils.TimeStampedPVCoordinates
Linear constructor
TimeStampedPVCoordinates(AbsoluteDate, FieldVector3D<DerivativeStructure>) - Constructor for class org.orekit.utils.TimeStampedPVCoordinates
Builds a TimeStampedPVCoordinates triplet from a FieldVector3D<DerivativeStructure>.
TIRFProvider - Class in org.orekit.frames.transformations
Terrestrial Intermediate Reference Frame 2000.
TIRFProvider() - Constructor for class org.orekit.frames.transformations.TIRFProvider
Simple constructor.
TLE - Class in org.orekit.propagation.analytical.tle
This class is a container for a single set of TLE data.
TLE(String, String) - Constructor for class org.orekit.propagation.analytical.tle.TLE
Simple constructor from unparsed two lines.
TLE(int, char, int, int, String, int, int, AbsoluteDate, double, double, double, double, double, double, double, double, int, double) - Constructor for class org.orekit.propagation.analytical.tle.TLE
Simple constructor from already parsed elements.
tle - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
Initial state.
TLEPropagator - Class in org.orekit.propagation.analytical.tle
This class provides elements to propagate TLE's.
TLEPropagator(TLE, AttitudeProvider, MassProvider) - Constructor for class org.orekit.propagation.analytical.tle.TLEPropagator
Protected constructor for derived classes.
TLEPropagator(TLE, AttitudeProvider, AttitudeProvider, MassProvider) - Constructor for class org.orekit.propagation.analytical.tle.TLEPropagator
Protected constructor for derived classes.
TLESeries - Class in org.orekit.propagation.analytical.tle
This class reads and handles series of TLEs for one space object.
TLESeries(String, boolean) - Constructor for class org.orekit.propagation.analytical.tle.TLESeries
Simple constructor with a TLE file.
toArray() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get the vector coordinates as a dimension 3 array.
toArray() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get the vector coordinates as a dimension 3 array.
toArray() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get the vector coordinates as a dimension 2 array.
toArray() - Method in class org.apache.commons.math3.linear.ArrayFieldVector
Convert the vector to a T array.
toArray() - Method in class org.apache.commons.math3.linear.ArrayRealVector
Convert the vector to an array of doubles.
toArray() - Method in interface org.apache.commons.math3.linear.FieldVector
Convert the vector to a T array.
toArray() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Convert the vector to an array of doubles.
toArray() - Method in class org.apache.commons.math3.linear.RealVector
Convert the vector to an array of doubles.
toArray() - Method in class org.apache.commons.math3.linear.SparseFieldVector
Deprecated. Convert the vector to a T array.
toBlocksLayout(T[][]) - Static method in class org.apache.commons.math3.linear.BlockFieldMatrix
Convert a data array from raw layout to blocks layout.
toBlocksLayout(double[][]) - Static method in class org.apache.commons.math3.linear.BlockRealMatrix
Convert a data array from raw layout to blocks layout.
ToCelestialBodyCenterDirection - Class in org.orekit.attitudes.directions
Direction described by a celestial body : the celestial body's center is the target point.
ToCelestialBodyCenterDirection(CelestialBody) - Constructor for class org.orekit.attitudes.directions.ToCelestialBodyCenterDirection
Build a direction described by a celestial body : the celestial body's center is the target point.
toDate(TimeScale) - Method in class org.orekit.time.AbsoluteDate
Convert the instance to a Java Date.
toDegrees() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Convert radians to degrees, with error of less than 0.5 ULP
toDegrees(double) - Static method in class org.apache.commons.math3.util.FastMath
Convert radians to degrees, with error of less than 0.5 ULP
toDerivativeStructureVector(int) - Method in class org.orekit.utils.PVCoordinates
Transform the instance to a FieldVector3D<DerivativeStructure>.
toDifferentiableMultivariateFunction(MultivariateDifferentiableFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated. this conversion method is temporary in version 3.1, as the DifferentiableMultivariateFunction interface itself is deprecated
toDifferentiableMultivariateVectorFunction(MultivariateDifferentiableVectorFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated. this conversion method is temporary in version 3.1, as the DifferentiableMultivariateVectorFunction interface itself is deprecated
toDifferentiableUnivariateFunction(UnivariateDifferentiableFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated. this conversion method is temporary in version 3.1, as the DifferentiableUnivariateFunction interface itself is deprecated
toDouble() - Method in class org.apache.commons.math3.dfp.Dfp
Convert the instance into a double.
TODProvider - Class in org.orekit.frames.transformations
True Equator, Mean Equinox of Date Frame.
TODProvider(boolean) - Constructor for class org.orekit.frames.transformations.TODProvider
Simple constructor.
tolerances(double, Orbit, OrbitType) - Static method in class org.orekit.propagation.numerical.NumericalPropagator
Estimate tolerance vectors for integrators.
toMean(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.orbits.OrbitNatureConverter
Converts an osculating StelaEquinoctialOrbit to a mean one.
toMultivariateDifferentiableFunction(DifferentiableMultivariateFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated. this conversion method is temporary in version 3.1, as the DifferentiableMultivariateFunction interface itself is deprecated
toMultivariateDifferentiableVectorFunction(DifferentiableMultivariateVectorFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated. this conversion method is temporary in version 3.1, as the DifferentiableMultivariateFunction interface itself is deprecated
ToolsMessages - Enum in fr.cnes.sirius.patrius.tools.exception.util
Enumeration for localized messages formats used in exceptions messages.
TooManyEvaluationsException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the maximal number of evaluations is exceeded.
TooManyEvaluationsException(Number) - Constructor for exception org.apache.commons.math3.exception.TooManyEvaluationsException
Construct the exception.
TooManyIterationsException - Exception in org.apache.commons.math3.exception
Exception to be thrown when the maximal number of iterations is exceeded.
TooManyIterationsException(Number) - Constructor for exception org.apache.commons.math3.exception.TooManyIterationsException
Construct the exception.
toOsculating(StelaEquinoctialOrbit) - Method in class fr.cnes.sirius.patrius.stela.orbits.OrbitNatureConverter
Converts a mean StelaEquinoctialOrbit to an osculating one.
TopocentricFrame - Class in org.orekit.frames
Topocentric frame.
TopocentricFrame(BodyShape, GeodeticPoint, String) - Constructor for class org.orekit.frames.TopocentricFrame
This constructor builds an east oriented topocentric frame.
TopocentricFrame(BodyShape, GeodeticPoint, double, String) - Constructor for class org.orekit.frames.TopocentricFrame
This constructor builds a topocentric frame which Z-axis is the zenith.
TopocentricPosition - Class in org.orekit.utils
 
TopocentricPosition(double, double, double) - Constructor for class org.orekit.utils.TopocentricPosition
Build topocentic coordinates.
TopocentricPV - Class in org.orekit.utils
 
TopocentricPV(double, double, double, double, double, double) - Constructor for class org.orekit.utils.TopocentricPV
Build topocentric coordinates.
toRadians() - Method in class org.apache.commons.math3.analysis.differentiation.DerivativeStructure
Convert degrees to radians, with error of less than 0.5 ULP
toRadians(double) - Static method in class org.apache.commons.math3.util.FastMath
Convert degrees to radians, with error of less than 0.5 ULP
toRotation() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldRotation
Convert to a constant vector without derivatives.
toSpace(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Transform a sub-space point into a space point.
toSpace(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Transform an in-plane point into a 3D space point.
toSpace(Vector<Euclidean1D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Transform a sub-space point into a space point.
toSpace(Vector<T>) - Method in interface org.apache.commons.math3.geometry.partitioning.Embedding
Transform a sub-space point into a space point.
toSplitDouble() - Method in class org.apache.commons.math3.dfp.Dfp
Convert the instance into a split double.
toString() - Method in class fr.cnes.sirius.patrius.events.CodedEvent
Provides a String representation, based on this pattern : "<date> - <(Beg) or (End)> - <code> : <comment>".
toString() - Method in class fr.cnes.sirius.patrius.events.CodedEventsList
 
toString() - Method in class fr.cnes.sirius.patrius.events.PhenomenaList
 
toString() - Method in class fr.cnes.sirius.patrius.events.Phenomenon
 
toString() - Method in class fr.cnes.sirius.patrius.fieldsofview.EllipticField
Get a representation for this infinite oblique circular cone.
toString() - Method in class fr.cnes.sirius.patrius.utils.AngleInterval
This method returns a String representing the interval, with boundaries as brackets and the lower/upper values.
Example : "] 0.0 rad , 1.2534 rad [" for an open interval.
Warning : this representation is subject to change.
toString() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Get String representation of polynomial
toString() - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeriesApproximation
Get String representation of Fourier Series
toString() - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Returns a string representation of the polynomial.
toString() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Get String representation of polynomial
toString() - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get String representation of polynomial
toString() - Method in class org.apache.commons.math3.complex.Complex
toString() - Method in class org.apache.commons.math3.complex.Quaternion
toString() - Method in class org.apache.commons.math3.dfp.Dfp
Get a string representation of the instance.
toString() - Method in class org.apache.commons.math3.exception.util.DummyLocalizable
toString() - Method in class org.apache.commons.math3.fraction.BigFraction
Returns the String representing this fraction, ie "num / dem" or just "num" if the denominator is one.
toString() - Method in class org.apache.commons.math3.fraction.Fraction
Returns the String representing this fraction, ie "num / dem" or just "num" if the denominator is one.
toString() - Method in class org.apache.commons.math3.genetics.AbstractListChromosome
 
toString() - Method in class org.apache.commons.math3.genetics.ChromosomePair
 
toString() - Method in class org.apache.commons.math3.genetics.ListPopulation
toString() - Method in class org.apache.commons.math3.genetics.RandomKey
 
toString() - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get a string representation of this vector.
toString(NumberFormat) - Method in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Get a string representation of this vector.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Disk
Get a string representation for this disk.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipse
Get a string representation for this ellipse.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Ellipsoid
Get a representation for this ellipsoid.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCone
Get a representation for this oblique circular cone.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.EllipticCylinder
Get a string representation for this elliptic cylinder.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a string representation of this vector.
toString(NumberFormat) - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Get a string representation of this vector.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCone
Get a representation for this infinite oblique circular cone.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteEllipticCylinder
Get a representation for this infinite elliptic cylinder.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCone
Get a representation for this infinite rectangle cone.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRectangleCylinder
Get a representation for this infinite rectangle cylinder.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCone
Get a representation for this infinite elliptic cone.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.InfiniteRightCircularCylinder
Get a representation for this infinite right circular cylinder.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.LineSegment
Get a representation for this line segment.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Get a string representation for this matrix.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Parallelepiped
Get a representation for this parallelepiped.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plate
Get a representation for this plate.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RectangleCone
Get a representation for this rectangle cone.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCone
Get a representation for this elliptic cone.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RightCircularCylinder
Get a representation for this right circular cylinder.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Rotation
Get a string representation for the rotation.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Get a string representation of the instance.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Screw
Get a String representation of this screw.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Sphere
Get a representation for this sphere.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.SphericalCap
Get a representation for this sphere.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Spheroid
Get a representation for this spheroid.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a string representation of this vector.
toString(NumberFormat) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Get a string representation of this vector.
toString() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get a string representation of this vector.
toString(NumberFormat) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Get a string representation of this vector.
toString(NumberFormat) - Method in interface org.apache.commons.math3.geometry.Vector
Get a string representation of this vector.
toString() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Get a string representation for this matrix.
toString() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Get a string representation for this matrix.
toString() - Method in class org.apache.commons.math3.linear.ArrayRealVector
toString() - Method in enum org.apache.commons.math3.optim.linear.Relationship
 
toString() - Method in enum org.apache.commons.math3.optimization.linear.Relationship
Deprecated.  
toString() - Method in class org.apache.commons.math3.stat.clustering.EuclideanDoublePoint
toString() - Method in class org.apache.commons.math3.stat.clustering.EuclideanIntegerPoint
toString() - Method in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
Generates a text report displaying univariate statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.MultivariateSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.StatisticalSummaryValues
Generates a text report displaying values of statistics.
toString() - Method in class org.apache.commons.math3.stat.descriptive.SummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedDescriptiveStatistics
Generates a text report displaying univariate statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.descriptive.SynchronizedSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math3.stat.Frequency
Return a string representation of this frequency distribution.
toString() - Method in class org.apache.commons.math3.util.Decimal64
The returned String is equal to Double.toString(this.doubleValue())
toString() - Method in class org.apache.commons.math3.util.MultidimensionalCounter
toString() - Method in class org.orekit.frames.Frame
New definition of the java.util toString() method.
toString() - Method in class org.orekit.models.earth.GeoMagneticElements
 
toString() - Method in class org.orekit.orbits.ApsisOrbit
Returns a string representation of this Orbit object.
toString() - Method in class org.orekit.orbits.CartesianOrbit
Returns a string representation of this Orbit object.
toString() - Method in class org.orekit.orbits.CircularOrbit
Returns a string representation of this Orbit object.
toString() - Method in class org.orekit.orbits.EquatorialOrbit
Returns a string representation of this non circular equatorial orbital parameters object.
toString() - Method in class org.orekit.orbits.EquinoctialOrbit
Returns a string representation of this equinoctial parameters object.
toString() - Method in class org.orekit.orbits.KeplerianOrbit
Returns a string representation of this keplerian parameters object.
toString() - Method in class org.orekit.orbits.orbitalparameters.ApsisAltitudeParameters
Returns a string representation of this Orbit object.
toString() - Method in class org.orekit.orbits.orbitalparameters.ApsisRadiusParameters
Returns a string representation of this Orbit object.
toString() - Method in class org.orekit.orbits.orbitalparameters.CartesianParameters
Returns a string representation of this Orbit object.
toString() - Method in class org.orekit.orbits.orbitalparameters.CircularParameters
Returns a string representation of this Orbit object.
toString() - Method in class org.orekit.orbits.orbitalparameters.EquatorialParameters
Returns a string representation of this non circular equatorial orbital parameters object.
toString() - Method in class org.orekit.orbits.orbitalparameters.EquinoctialParameters
Returns a string representation of this orbit parameters object.
toString() - Method in class org.orekit.orbits.orbitalparameters.KeplerianParameters
Returns a string representation of this keplerian parameters object.
toString() - Method in class org.orekit.orbits.orbitalparameters.ReentryParameters
Returns a string representation of the reentry parameters.
toString() - Method in class org.orekit.orbits.orbitalparameters.StelaEquinoctialParameters
Returns a string representation of this orbit parameters object.
toString() - Method in class org.orekit.propagation.analytical.tle.TLE
Get a string representation of this TLE set.
toString() - Method in enum org.orekit.propagation.numerical.AttitudeEquation.AttitudeType
 
toString() - Method in class org.orekit.time.AbsoluteDate
Get a String representation of the instant location in TAI time scale.
toString(int) - Method in class org.orekit.time.AbsoluteDate
Get a String representation of the instant location in TAI time scale.
toString(TimeScale) - Method in class org.orekit.time.AbsoluteDate
Get a String representation of the instant location.
toString(int, TimeScale) - Method in class org.orekit.time.AbsoluteDate
Get a String representation of the instant location.
toString() - Method in class org.orekit.time.DateComponents
Get a string representation (ISO-8601) of the date.
toString() - Method in class org.orekit.time.DateTimeComponents
Return a string representation of this pair.
toString(int, boolean) - Method in class org.orekit.time.DateTimeComponents
Return a string representation of this pair.
toString() - Method in class org.orekit.time.GalileoScale
toString() - Method in class org.orekit.time.GMSTScale
toString() - Method in class org.orekit.time.GPSScale
toString() - Method in class org.orekit.time.TAIScale
toString() - Method in class org.orekit.time.TCBScale
toString() - Method in class org.orekit.time.TCGScale
toString() - Method in class org.orekit.time.TDBScale
toString() - Method in class org.orekit.time.TimeComponents
Get a string representation of the time.
toString(int, boolean) - Method in class org.orekit.time.TimeComponents
Get a string representation of the time.
toString() - Method in class org.orekit.time.TTScale
toString() - Method in class org.orekit.time.UT1Scale
toString() - Method in class org.orekit.time.UTCScale
toString() - Method in class org.orekit.utils.CardanMountPosition
Produces the following String representation of the Cardan mount : (x angle, y angle, range).
toString() - Method in class org.orekit.utils.CardanMountPV
Produces the following String representation of the Topocentric coordinates : (x angle, y angle, range, x angle rate, y angle rate, range rate).
toString() - Method in class org.orekit.utils.GenericInterval
This method returns a String representing the interval, with boundaries as brackets and the lower/upper values.
Example : "] 0.0 , 1.2534 [" for an open interval with doubles.
toString is called on the values.
Warning : this representation is subject to change.
This method may be overriden if convenient.
toString() - Method in class org.orekit.utils.PVCoordinates
Return a string representation of this position/velocity/acceleration triplet.
toString() - Method in class org.orekit.utils.TimeStampedPVCoordinates
Return a string representation of this position/velocity pair.
toString() - Method in class org.orekit.utils.TopocentricPosition
Produces the following String representation of the topocentric coordinates : (elevation, azimuth, range).
toString() - Method in class org.orekit.utils.TopocentricPV
Produces the following String representation of the Topocentric coordinates : (elevation, azimuth, range, elevation rate, azimuth rate, range rate).
toString() - Method in class org.orekit.wrenches.Wrench
Get a String representation for this Wrench.
toSubSpace(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Transform a space point into a sub-space point.
toSubSpace(Vector<Euclidean3D>) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Transform a 3D space point into an in-plane point.
toSubSpace(Vector<Euclidean2D>) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Transform a space point into a sub-space point.
toSubSpace(Vector<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.Embedding
Transform a space point into a sub-space point.
toTLE(List<SpacecraftState>, double, boolean, boolean) - Method in class org.orekit.propagation.analytical.tle.AbstractTLEFitter
Find the TLE elements that minimize the mean square error for a sample of states.
toTransform() - Method in class org.orekit.propagation.SpacecraftState
Compute the transform from orbit/attitude reference frame to spacecraft frame.
toTransform(Frame) - Method in class org.orekit.propagation.SpacecraftState
Compute the transform from specified frame to spacecraft frame.
toTransform(LOFType) - Method in class org.orekit.propagation.SpacecraftState
Compute the transform from orbit/attitude reference frame to local orbital frame.
toTransform(Frame, LOFType) - Method in class org.orekit.propagation.SpacecraftState
Compute the transform from specified frame to local orbital frame.
toTransformEvents() - Method in class org.orekit.propagation.SpacecraftState
Compute the transform from orbit/attitude (for events computation) reference frame to spacecraft frame.
toTransformEvents(Frame) - Method in class org.orekit.propagation.SpacecraftState
Compute the transform from specified reference frame to spacecraft frame.
toTransformForces() - Method in class org.orekit.propagation.SpacecraftState
Compute the transform from orbit/attitude (for forces computation) reference frame to spacecraft frame.
toTransformForces(Frame) - Method in class org.orekit.propagation.SpacecraftState
Compute the transform from specified frame to spacecraft frame.
toUnivariateDifferential(DifferentiableUnivariateFunction) - Static method in class org.apache.commons.math3.analysis.FunctionUtils
Deprecated. this conversion method is temporary in version 3.1, as the DifferentiableUnivariateFunction interface itself is deprecated
TournamentSelection - Class in org.apache.commons.math3.genetics
Tournament selection scheme.
TournamentSelection(int) - Constructor for class org.apache.commons.math3.genetics.TournamentSelection
Creates a new TournamentSelection instance.
toVector3D() - Method in class org.apache.commons.math3.geometry.euclidean.threed.FieldVector3D
Convert to a constant vector without derivatives.
tPVCoord - Variable in class org.orekit.utils.AbstractBoundedPVProvider
Position velocity coordinates table
Transform<S extends Space,T extends Space> - Interface in org.apache.commons.math3.geometry.partitioning
This interface represents an inversible affine transform in a space.
transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.apache.commons.math3.transform.AbstractFastFourierTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(double[], TransformType) - Method in class org.apache.commons.math3.transform.FastCosineTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.apache.commons.math3.transform.FastCosineTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(double[], TransformType) - Method in class org.apache.commons.math3.transform.FastFourierTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(Complex[], TransformType) - Method in class org.apache.commons.math3.transform.FastFourierTransformer
Returns the (forward, inverse) transform of the specified complex data set.
transform(double[], TransformType) - Method in class org.apache.commons.math3.transform.FastHadamardTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.apache.commons.math3.transform.FastHadamardTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(int[]) - Method in class org.apache.commons.math3.transform.FastHadamardTransformer
Returns the forward transform of the specified integer data set.The integer transform cannot be inverted directly, due to a scaling factor which may lead to double results.
transform(double[], TransformType) - Method in class org.apache.commons.math3.transform.FastSineTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in class org.apache.commons.math3.transform.FastSineTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(double[], TransformType) - Method in interface org.apache.commons.math3.transform.IFastFourierTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(Complex[], TransformType) - Method in interface org.apache.commons.math3.transform.IFastFourierTransformer
Returns the (forward, inverse) transform of the specified complex data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in interface org.apache.commons.math3.transform.IFastFourierTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(double[], TransformType) - Method in interface org.apache.commons.math3.transform.RealTransformer
Returns the (forward, inverse) transform of the specified real data set.
transform(UnivariateFunction, double, double, int, TransformType) - Method in interface org.apache.commons.math3.transform.RealTransformer
Returns the (forward, inverse) transform of the specified real function, sampled on the specified interval.
transform(Object) - Method in class org.apache.commons.math3.util.DefaultTransformer
 
transform(Object) - Method in interface org.apache.commons.math3.util.NumberTransformer
Implementing this interface provides a facility to transform from Object to Double.
transform(Object) - Method in class org.apache.commons.math3.util.TransformerMap
Attempts to transform the Object against the map of NumberTransformers.
transform(Vector3D, Frame, AbsoluteDate) - Method in interface org.orekit.bodies.BodyShape
Transform a cartesian point to a surface-relative point.
transform(GeodeticPoint) - Method in interface org.orekit.bodies.BodyShape
Transform a surface-relative point to a cartesian point.
transform(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
 
transform(GeodeticPoint) - Method in class org.orekit.bodies.ExtendedOneAxisEllipsoid
 
transform(GeodeticPoint) - Method in class org.orekit.bodies.OneAxisEllipsoid
Transform a surface-relative point to a cartesian point.
transform(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.bodies.OneAxisEllipsoid
Transform a cartesian point to a surface-relative point.
Transform - Class in org.orekit.frames.transformations
Transformation class in three dimensional space.
Transform(AbsoluteDate, Vector3D) - Constructor for class org.orekit.frames.transformations.Transform
Build a translation transform.
Transform(AbsoluteDate, Rotation) - Constructor for class org.orekit.frames.transformations.Transform
Build a rotation transform.
Transform(AbsoluteDate, Vector3D, Vector3D) - Constructor for class org.orekit.frames.transformations.Transform
Build a translation transform, with its first time derivative.
Transform(AbsoluteDate, Vector3D, Vector3D, Vector3D) - Constructor for class org.orekit.frames.transformations.Transform
Build a translation transform, with its first and second time derivatives.
Transform(AbsoluteDate, PVCoordinates) - Constructor for class org.orekit.frames.transformations.Transform
Build a translation transform, with its first time derivative.
Transform(AbsoluteDate, Rotation, Vector3D) - Constructor for class org.orekit.frames.transformations.Transform
Build a rotation transform.
Transform(AbsoluteDate, Rotation, Vector3D, Vector3D) - Constructor for class org.orekit.frames.transformations.Transform
Build a rotation transform.
Transform(AbsoluteDate, AngularCoordinates) - Constructor for class org.orekit.frames.transformations.Transform
Build a rotation transform.
Transform(AbsoluteDate, Transform, Transform) - Constructor for class org.orekit.frames.transformations.Transform
Build a transform by combining two existing ones without computing spin derivatives.
Transform(AbsoluteDate, Transform, Transform, boolean) - Constructor for class org.orekit.frames.transformations.Transform
Build a transform by combining two existing ones.
Transform(AbsoluteDate, PVCoordinates, AngularCoordinates) - Constructor for class org.orekit.frames.transformations.Transform
Build a transform from its primitive operations.
transformAndComputeJacobian(GeodeticPoint, double[][]) - Method in class org.orekit.bodies.OneAxisEllipsoid
Transform a surface-relative point to a cartesian point and compute the jacobian of the transformation.
transformAndComputeJacobian(Vector3D, Frame, AbsoluteDate, double[][]) - Method in class org.orekit.bodies.OneAxisEllipsoid
Transform a cartesian point to a surface-relative point and compute the jacobian of the transformation.
TransformerMap - Class in org.apache.commons.math3.util
This TansformerMap automates the transformation of mixed object types.
TransformerMap() - Constructor for class org.apache.commons.math3.util.TransformerMap
Build a map containing only the default transformer.
transformers() - Method in class org.apache.commons.math3.util.TransformerMap
Returns the Set of NumberTransformers used as values in the map.
transformFromCardanToPosition(CardanMountPosition) - Method in class org.orekit.frames.TopocentricFrame
Transform a Cardan mounting into Cartesian coordinates (only position) expressed in this local topocentric frame.
transformFromCardanToPV(CardanMountPV) - Method in class org.orekit.frames.TopocentricFrame
Transform a Cardan mounting into Cartesian coordinates (position and velocity) expressed in this local topocentric frame.
transformFromInertial(AbsoluteDate, PVCoordinates, boolean) - Method in enum org.orekit.frames.LOFType
Get the transform from an inertial frame defining position-velocity and the local orbital frame.
transformFromInertial(AbsoluteDate, PVCoordinates) - Method in enum org.orekit.frames.LOFType
Get the transform from an inertial frame defining position-velocity and the local orbital frame.
transformFromPositionToCardan(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Transform a Cartesian position coordinates into Cardan mounting in this local topocentric frame.
transformFromPositionToTopocentric(Vector3D, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Transform a Cartesian position coordinates into topocentric coordinates in this local topocentric frame.
transformFromPVToCardan(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Transform a Cartesian position coordinates into Cardan mounting in this local topocentric frame.
transformFromPVToTopocentric(PVCoordinates, Frame, AbsoluteDate) - Method in class org.orekit.frames.TopocentricFrame
Transform a Cartesian position and velocity coordinates into topocentric coordinates in this local topocentric frame.
transformFromTopocentricToPosition(TopocentricPosition) - Method in class org.orekit.frames.TopocentricFrame
Transform topocentric set of coordinates frame into Cartesian position coordinates expressed in this local topocentric.
transformFromTopocentricToPV(TopocentricPV) - Method in class org.orekit.frames.TopocentricFrame
Transform topocentric set of coordinates into Cartesian position and velocity coordinates expressed in this local topocentric frame .
transformLine(Line) - Method in class org.orekit.frames.transformations.Transform
Transform a line from an algebraic point of view.
transformModel(double) - Method in class org.orekit.models.earth.GeoMagneticField
Time transform the model coefficients from the base year of the model using secular variation coefficients.
transformModel(GeoMagneticField, double) - Method in class org.orekit.models.earth.GeoMagneticField
Time transform the model coefficients from the base year of the model using a linear interpolation with a second model.
transformPosition(Vector3D) - Method in class org.orekit.frames.transformations.Transform
Transform a position vector (including translation effects).
TransformProvider - Interface in org.orekit.frames.transformations
Interface for Transform providers.
transformPVCoordinates(PVCoordinates) - Method in class org.orekit.frames.transformations.Transform
Transform PVCoordinates including kinematic effects from an algebraic point of view.
transformPVCoordinates(TimeStampedPVCoordinates) - Method in class org.orekit.frames.transformations.Transform
Transform TimeStampedPVCoordinates including kinematic effects.
TransformType - Enum in org.apache.commons.math3.transform
This enumeration defines the type of transform which is to be computed.
TransformUtils - Class in org.apache.commons.math3.transform
Useful functions for the implementation of various transforms.
transformVector(Vector3D) - Method in class org.orekit.frames.transformations.Transform
Transform a vector (ignoring translation effects).
transformWrench(Wrench) - Method in class org.orekit.frames.transformations.Transform
Transform a wrench (ignoring translation effects).
transitions - Variable in class org.orekit.attitudes.AbstractAttitudeEphemerisGenerator
Flag specifying what to do with the attitude laws transition points.
translate(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Translate the plane by the specified amount.
translate(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.PolyhedronsSet
Translate the region by the specified amount.
translateToPoint(Vector2D) - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Translate the line to force it passing by a point.
transpose() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Computes the transposition of this Matrix3D
transpose() - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Returns the transpose of this matrix.
transpose() - Method in interface org.apache.commons.math3.linear.FieldMatrix
Returns the transpose of this matrix.
transpose() - Method in interface org.apache.commons.math3.linear.RealMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math3.linear.SymmetricMatrix
Returns the transpose of this matrix.
transposeAndMultiply(Vector3D) - Method in class org.apache.commons.math3.geometry.euclidean.threed.Matrix3D
Computes the multiplication of the transposed matrix of this Matrix3D with a Vector3D
trap(int, String, Dfp, Dfp, Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Trap handler.
TRAPEZOID_MAX_ITERATIONS_COUNT - Static variable in class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
Maximum number of iterations for trapezoid.
TrapezoidIntegrator - Class in org.apache.commons.math3.analysis.integration
Implements the Trapezoid Rule for integration of real univariate functions.
TrapezoidIntegrator(double, double, int, int) - Constructor for class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
Build a trapezoid integrator with given accuracies and iterations counts.
TrapezoidIntegrator(int, int) - Constructor for class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
Build a trapezoid integrator with given iteration counts.
TrapezoidIntegrator() - Constructor for class org.apache.commons.math3.analysis.integration.TrapezoidIntegrator
Construct a trapezoid integrator with default settings.
TriangularDistribution - Class in org.apache.commons.math3.distribution
Implementation of the triangular real distribution.
TriangularDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.TriangularDistribution
Creates a triangular real distribution using the given lower limit, upper limit, and mode.
TriangularDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.TriangularDistribution
Creates a triangular distribution.
TricubicSplineInterpolatingFunction - Class in org.apache.commons.math3.analysis.interpolation
Function that implements the tricubic spline interpolation, as proposed in Tricubic interpolation in three dimensions
F.
TricubicSplineInterpolatingFunction(double[], double[], double[], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolatingFunction
 
TricubicSplineInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Generates a tricubic interpolating function.
TricubicSplineInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolator
 
trigamma(double) - Static method in class org.apache.commons.math3.special.Gamma
Computes the trigamma function of x.
trigger(int) - Method in interface org.apache.commons.math3.util.Incrementor.MaxCountExceededCallback
Function called when the maximal count has been reached.
TrigonometricPolynomialFunction - Class in org.apache.commons.math3.analysis.polynomials
This class is the Trigonometric Polynomial Function class.
TrigonometricPolynomialFunction(double, double[], double[]) - Constructor for class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Constructor for the TrigonometricPolynomialFunction.
TrigonometricPolynomialPrimitive - Class in org.apache.commons.math3.analysis.polynomials
This class represents a trigonometric polynomial primitive.
TrigonometricPolynomialPrimitive(PolynomialFunction, TrigonometricPolynomialFunction) - Constructor for class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Constructor for the TrigonometricPolynomialPrimitive class
TriLinearIntervalsFunction - Class in org.apache.commons.math3.analysis.interpolation
Implements the representation of a linear function in dimension 2.
TriLinearIntervalsFunction(double[], double[], double[], double[][][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.TriLinearIntervalsFunction
Constructor, in three dimensions.
TriLinearIntervalsFunction(ISearchIndex, ISearchIndex, ISearchIndex, double[][][]) - Constructor for class org.apache.commons.math3.analysis.interpolation.TriLinearIntervalsFunction
Constructor, in three dimensions with a search index algorithm as a parameter.
TriLinearIntervalsInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Class representing a TrivariateGridInterpolator for linear interpolation in dimension 3.
TriLinearIntervalsInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.TriLinearIntervalsInterpolator
 
TrivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a trivariate real function.
TrivariateGridInterpolator - Interface in org.apache.commons.math3.analysis.interpolation
Interface representing a trivariate real interpolating function where the sample points must be specified on a regular grid.
TroposphericCorrection - Interface in org.orekit.models.earth
Defines a tropospheric model, used to calculate the signal delay for the signal path imposed to electro-magnetic signals between an orbital satellite and a ground station.
TRUE_ANOMALY - Static variable in class org.orekit.orbits.KeplerianOrbit
Deprecated. as of 6.0 replaced by PositionAngle
TRUE_LATITUDE_ARGUMENT - Static variable in class org.orekit.orbits.EquinoctialOrbit
Deprecated. as of 6.0 replaced by PositionAngle
TRUE_LONGITUDE_ARGUMENT - Static variable in class org.orekit.orbits.CircularOrbit
Deprecated. as of 6.0 replaced by PositionAngle
trunc(DfpField.RoundingMode) - Method in class org.apache.commons.math3.dfp.Dfp
Does the integer conversions with the specified rounding.
tselec() - Method in class org.orekit.forces.atmospheres.MSIS2000.Flags
Prepare sw and swc.
tsi - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
tsi from SPTRCK #3.
tTest(double, double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double, double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double, StatisticalSummary, double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double[], double[], double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(double[], double[]) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(StatisticalSummary, StatisticalSummary, double) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
tTest(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math3.stat.inference.TestUtils
 
TTest - Class in org.apache.commons.math3.stat.inference
An implementation for Student's t-tests.
TTest() - Constructor for class org.apache.commons.math3.stat.inference.TTest
 
tTest(double, double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the input array with the constant mu.
tTest(double, double[], double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which sample is drawn equals mu.
tTest(double, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the dataset described by sampleStats with the constant mu.
tTest(double, StatisticalSummary, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which the dataset described by stats is drawn equals mu.
tTest(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays.
tTest(double[], double[], double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha.
tTest(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math3.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances.
tTest(StatisticalSummary, StatisticalSummary, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sampleStats1 and sampleStats2 describe datasets drawn from populations with the same mean, with significance level alpha.
tTest(double, double, double, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes p-value for 2-sided, 1-sample t-test.
tTest(double, double, double, double, double, double) - Method in class org.apache.commons.math3.stat.inference.TTest
Computes p-value for 2-sided, 2-sample t-test.
TTScale - Class in org.orekit.time
Terrestrial Time as defined by IAU(1991) recommendation IV.
TWELVE - Static variable in class org.orekit.forces.atmospheres.solarActivity.specialized.AbstractMSISE2000SolarData
Constant 12
TWO - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "2 / 1".
TWO - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "2 / 1".
TWO_FIFTHS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "2/5".
TWO_FIFTHS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "2/5".
TWO_PI - Static variable in class org.apache.commons.math3.util.MathUtils
2 π.
TWO_QUARTERS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "2/4".
TWO_QUARTERS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "2/4".
TWO_THIRDS - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "2/3".
TWO_THIRDS - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "2/3".
TwoDirectionsAttitude - Class in org.orekit.attitudes
This class implements a generic two directions attitude law.
TwoDirectionsAttitude(IDirection, IDirection, Vector3D, Vector3D) - Constructor for class org.orekit.attitudes.TwoDirectionsAttitude
Constructor.
TwoSpinBiasSlew - Class in org.orekit.attitudes
This class extends the AbstractSlew.
TwoSpinBiasSlew(AttitudeProvider, AttitudeProvider, AbsoluteDate, double, double, double, double, double, double, double, double, double) - Constructor for class org.orekit.attitudes.TwoSpinBiasSlew
This class extends the AbstractSlew.

U

UAI1994_EARTH_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Earth standard gravitational parameter from CNES COMPAS_Base data set.
UAI1994_EARTH_FLATTENING - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Earth flattening from CNES COMPAS_Base data set.
UAI1994_EARTH_GRAVITATIONAL_PARAMETER - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Earth standard gravitational parameter from CNES COMPAS_Base data set.
UAI1994_EARTH_J2 - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Earth J2 parameter from CNES COMPAS_Base data set.
UAI1994_EARTH_ROTATION_RATE - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Earth rotation rate from CNES COMPAS_Base data set.
UAI1994_GRAVITATIONAL_CONSTANT - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 gravitational constant (m3kg-1s-2) from CNES COMPAS_Base data set.
UAI1994_LIGHT_VELOCITY - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 light velocity in vacuum (meters per second) from CNES COMPAS_Base data set.
UAI1994_MOON_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Moon equatorial radius from CNES COMPAS_Base data set.
UAI1994_MOON_FLATTENING - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Moon flattening from CNES COMPAS_Base data set.
UAI1994_MOON_GRAVITATIONAL_PARAMETER - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Moon standard gravitational parameter from CNES COMPAS_Base data set.
UAI1994_MOON_ROTATION_RATE - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Moon rotation rate from CNES COMPAS_Base data set.
UAI1994_OBLIQUITY - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 obliquity of the ecliptic (arcseconds) from CNES COMPAS_Base data set.
UAI1994_PRECESSION_RATE - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 precession rate (arcseconds/century) from CNES COMPAS_Base data set.
UAI1994_SOLAR_RADIATION_PRESSURE - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 solar radiation pressure coefficient from CNES COMPAS_Base data set.
UAI1994_SUN_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Sun equatorial radius from CNES COMPAS_Base data set.
UAI1994_SUN_FLATTENING - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Sun flattening from CNES COMPAS_Base data set.
UAI1994_SUN_GRAVITATIONAL_PARAMETER - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Sun standard gravitational parameter from CNES COMPAS_Base data set.
UAI1994_SUN_ROTATION_RATE - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 Sun rotation rate from CNES COMPAS_Base data set.
UAI1994_UA - Static variable in interface org.orekit.utils.CnesConstants
UAI1994 UA (m) from CNES COMPAS_Base data set.
UDDecomposition - Interface in org.apache.commons.math3.linear
An interface to classes that implement an algorithm to calculate the UD-decomposition of a real matrix.
UDDecompositionImpl - Class in org.apache.commons.math3.linear
Calculates the UD decomposition of a matrix.
UDDecompositionImpl(RealMatrix) - Constructor for class org.apache.commons.math3.linear.UDDecompositionImpl
Compute the UD decomposition of the given matrix.
UDDecompositionImpl(RealMatrix, double, double) - Constructor for class org.apache.commons.math3.linear.UDDecompositionImpl
Compute the UD decomposition of the given matrix.
Ulp - Class in org.apache.commons.math3.analysis.function
ulp function.
Ulp() - Constructor for class org.apache.commons.math3.analysis.function.Ulp
 
ulp(double) - Static method in class org.apache.commons.math3.util.FastMath
Compute least significant bit (Unit in Last Position) for a number.
ulp(float) - Static method in class org.apache.commons.math3.util.FastMath
Compute least significant bit (Unit in Last Position) for a number.
unbounded(int) - Static method in class org.apache.commons.math3.optim.SimpleBounds
Factory method that creates instance of this class that represents unbounded ranges.
UnboundedSolutionException - Exception in org.apache.commons.math3.optim.linear
This class represents exceptions thrown by optimizers when a solution escapes to infinity.
UnboundedSolutionException() - Constructor for exception org.apache.commons.math3.optim.linear.UnboundedSolutionException
Simple constructor using a default message.
UnboundedSolutionException - Exception in org.apache.commons.math3.optimization.linear
Deprecated. As of 3.1 (to be removed in 4.0).
UnboundedSolutionException() - Constructor for exception org.apache.commons.math3.optimization.linear.UnboundedSolutionException
Deprecated. Simple constructor using a default message.
unboundedToBounded(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
Maps an array from unbounded to bounded.
unboundedToBounded(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter
Deprecated. Map an array from unbounded to bounded.
UncorrelatedRandomVectorGenerator - Class in org.apache.commons.math3.random
A RandomVectorGenerator that generates vectors with uncorrelated components.
UncorrelatedRandomVectorGenerator(double[], double[], NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.UncorrelatedRandomVectorGenerator
Simple constructor.
UncorrelatedRandomVectorGenerator(int, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.UncorrelatedRandomVectorGenerator
Simple constructor.
unequal(Dfp) - Method in class org.apache.commons.math3.dfp.Dfp
Check if instance is not equal to x.
UNIFORM_MODE - Static variable in class org.apache.commons.math3.random.ValueServer
Uniform random deviates with mean = μ.
UniformCrossover<T> - Class in org.apache.commons.math3.genetics
Perform Uniform Crossover [UX] on the specified chromosomes.
UniformCrossover(double) - Constructor for class org.apache.commons.math3.genetics.UniformCrossover
Creates a new UniformCrossover policy using the given mixing ratio.
UniformIntegerDistribution - Class in org.apache.commons.math3.distribution
Implementation of the uniform integer distribution.
UniformIntegerDistribution(int, int) - Constructor for class org.apache.commons.math3.distribution.UniformIntegerDistribution
Creates a new uniform integer distribution using the given lower and upper bounds (both inclusive).
UniformIntegerDistribution(RandomGenerator, int, int) - Constructor for class org.apache.commons.math3.distribution.UniformIntegerDistribution
Creates a new uniform integer distribution using the given lower and upper bounds (both inclusive).
UniformlyCorrelatedRandomVectorGenerator - Class in org.apache.commons.math3.random
A RandomVectorGenerator that generates vectors with with correlated components.
UniformlyCorrelatedRandomVectorGenerator(double[], RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.UniformlyCorrelatedRandomVectorGenerator
Builds a correlated random vector generator from its mean vector and covariance matrix.
UniformlyCorrelatedRandomVectorGenerator(RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math3.random.UniformlyCorrelatedRandomVectorGenerator
Builds a null mean random correlated vector generator from its covariance matrix.
UniformRandomGenerator - Class in org.apache.commons.math3.random
This class implements a normalized uniform random generator.
UniformRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math3.random.UniformRandomGenerator
Create a new generator.
UniformRealDistribution - Class in org.apache.commons.math3.distribution
Implementation of the uniform real distribution.
UniformRealDistribution() - Constructor for class org.apache.commons.math3.distribution.UniformRealDistribution
Create a standard uniform real distribution with lower bound (inclusive) equal to zero and upper bound (exclusive) equal to one.
UniformRealDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.UniformRealDistribution
Create a uniform real distribution using the given lower and upper bounds.
UniformRealDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.UniformRealDistribution
Create a uniform distribution.
UniformRealDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.UniformRealDistribution
Creates a uniform distribution.
UniLinearIntervalsFunction - Class in org.apache.commons.math3.analysis.interpolation
Implements the representation of a linear function in dimension 1.
UniLinearIntervalsFunction(double[], double[]) - Constructor for class org.apache.commons.math3.analysis.interpolation.UniLinearIntervalsFunction
Constructor, in one dimension.
UniLinearIntervalsFunction(ISearchIndex, double[]) - Constructor for class org.apache.commons.math3.analysis.interpolation.UniLinearIntervalsFunction
Constructor, in one dimension with a search index algorithm as a parameter.
UniLinearIntervalsInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Class representing a univariate function for linear interpolation in dimension 1.
UniLinearIntervalsInterpolator() - Constructor for class org.apache.commons.math3.analysis.interpolation.UniLinearIntervalsInterpolator
 
union(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Compute the union of two regions.
unitize() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Converts this vector into a unit vector.
unitize() - Method in class org.apache.commons.math3.linear.RealVector
Converts this vector into a unit vector.
UnitSphereRandomVectorGenerator - Class in org.apache.commons.math3.random
Generate random vectors isotropically located on the surface of a sphere.
UnitSphereRandomVectorGenerator(int, RandomGenerator) - Constructor for class org.apache.commons.math3.random.UnitSphereRandomVectorGenerator
 
UnitSphereRandomVectorGenerator(int) - Constructor for class org.apache.commons.math3.random.UnitSphereRandomVectorGenerator
Create an object that will use a default RNG (MersenneTwister), in order to generate the individual components.
unitVector() - Method in class org.apache.commons.math3.linear.OpenMapRealVector
Deprecated. Creates a unit vector pointing in the direction of this vector.
unitVector() - Method in class org.apache.commons.math3.linear.RealVector
Creates a unit vector pointing in the direction of this vector.
UnivariateDateFunction - Interface in org.orekit.propagation.analytical.twod
This handles univariate functions.
UnivariateDfpFunction - Interface in org.apache.commons.math3.dfp
An interface representing a univariate Dfp function.
UnivariateDifferentiableFunction - Interface in org.apache.commons.math3.analysis.differentiation
Interface for univariate functions derivatives.
UnivariateDifferentiableMatrixFunction - Interface in org.apache.commons.math3.analysis.differentiation
Extension of UnivariateMatrixFunction representing a univariate differentiable matrix function.
UnivariateDifferentiableSolver - Interface in org.apache.commons.math3.analysis.solvers
Interface for (univariate real) rootfinding algorithms.
UnivariateDifferentiableVectorFunction - Interface in org.apache.commons.math3.analysis.differentiation
Extension of UnivariateVectorFunction representing a univariate differentiable vectorial function.
UnivariateFunction - Interface in org.apache.commons.math3.analysis
An interface representing a univariate real function.
UnivariateFunctionDifferentiator - Interface in org.apache.commons.math3.analysis.differentiation
Interface defining the function differentiation operation.
UnivariateIntegrator - Interface in org.apache.commons.math3.analysis.integration
Interface for univariate real integration algorithms.
UnivariateInterpolator - Interface in org.apache.commons.math3.analysis.interpolation
Interface representing a univariate real interpolating function.
UnivariateMatrixFunction - Interface in org.apache.commons.math3.analysis
An interface representing a univariate matrix function.
UnivariateMatrixFunctionDifferentiator - Interface in org.apache.commons.math3.analysis.differentiation
Interface defining the function differentiation operation.
UnivariateMultiStartOptimizer<FUNC extends UnivariateFunction> - Class in org.apache.commons.math3.optimization.univariate
Deprecated. As of 3.1 (to be removed in 4.0).
UnivariateMultiStartOptimizer(BaseUnivariateOptimizer<FUNC>, int, RandomGenerator) - Constructor for class org.apache.commons.math3.optimization.univariate.UnivariateMultiStartOptimizer
Deprecated. Create a multi-start optimizer from a single-start optimizer.
UnivariateObjectiveFunction - Class in org.apache.commons.math3.optim.univariate
Scalar function to be optimized.
UnivariateObjectiveFunction(UnivariateFunction) - Constructor for class org.apache.commons.math3.optim.univariate.UnivariateObjectiveFunction
 
UnivariateOptimizer - Class in org.apache.commons.math3.optim.univariate
Base class for a univariate scalar function optimizer.
UnivariateOptimizer(ConvergenceChecker<UnivariatePointValuePair>) - Constructor for class org.apache.commons.math3.optim.univariate.UnivariateOptimizer
 
UnivariateOptimizer - Interface in org.apache.commons.math3.optimization.univariate
Deprecated. As of 3.1 (to be removed in 4.0).
UnivariatePeriodicInterpolator - Class in org.apache.commons.math3.analysis.interpolation
Adapter for classes implementing the UnivariateInterpolator interface.
UnivariatePeriodicInterpolator(UnivariateInterpolator, double, int) - Constructor for class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
Builds an interpolator.
UnivariatePeriodicInterpolator(UnivariateInterpolator, double) - Constructor for class org.apache.commons.math3.analysis.interpolation.UnivariatePeriodicInterpolator
Builds an interpolator.
UnivariatePointValuePair - Class in org.apache.commons.math3.optim.univariate
This class holds a point and the value of an objective function at this point.
UnivariatePointValuePair(double, double) - Constructor for class org.apache.commons.math3.optim.univariate.UnivariatePointValuePair
Build a point/objective function value pair.
UnivariatePointValuePair - Class in org.apache.commons.math3.optimization.univariate
Deprecated. As of 3.1 (to be removed in 4.0).
UnivariatePointValuePair(double, double) - Constructor for class org.apache.commons.math3.optimization.univariate.UnivariatePointValuePair
Deprecated. Build a point/objective function value pair.
UnivariateSolver - Interface in org.apache.commons.math3.analysis.solvers
Interface for (univariate real) root-finding algorithms.
UnivariateSolverUtils - Class in org.apache.commons.math3.analysis.solvers
Utility routines for UnivariateSolver objects.
UnivariateStatistic - Interface in org.apache.commons.math3.stat.descriptive
Base interface implemented by all statistics.
UnivariateVectorFunction - Interface in org.apache.commons.math3.analysis
An interface representing a univariate vectorial function.
UnivariateVectorFunctionDifferentiator - Interface in org.apache.commons.math3.analysis.differentiation
Interface defining the function differentiation operation.
UnknownParameterException - Exception in org.apache.commons.math3.ode
Exception to be thrown when a parameter is unknown.
UnknownParameterException(String) - Constructor for exception org.apache.commons.math3.ode.UnknownParameterException
Construct an exception from the unknown parameter.
unlimited() - Static method in class org.apache.commons.math3.optim.MaxEval
Factory method that creates instance of this class that represents a virtually unlimited number of evaluations.
unlimited() - Static method in class org.apache.commons.math3.optim.MaxIter
Factory method that creates instance of this class that represents a virtually unlimited number of iterations.
unmodifiableRealVector(RealVector) - Static method in class org.apache.commons.math3.linear.RealVector
Returns an unmodifiable view of the specified vector.
unNormalize(double[][]) - Static method in class org.orekit.forces.gravity.GravityToolbox
Unnormalize a coefficients array.
unwrap(OrekitException) - Static method in exception org.orekit.errors.PropagationException
Recover a PropagationException, possibly embedded in a OrekitException.
unwrap(ExceptionContextProvider) - Static method in exception org.orekit.errors.PropagationException
Recover a PropagationException, possibly embedded in an ExceptionContextProvider.
unwrap(OrekitException) - Static method in exception org.orekit.errors.TimeStampedCacheException
Recover a PropagationException, possibly embedded in a OrekitException.
unwrap(ExceptionContextProvider) - Static method in exception org.orekit.errors.TimeStampedCacheException
Recover a PropagationException, possibly embedded in an ExceptionContextProvider.
UP - Static variable in class org.orekit.propagation.events.LatitudeDetector
Flag for local increasing latitude detection (g increasing).
UP_DOWN - Static variable in class org.orekit.propagation.events.LatitudeDetector
Flag for both local increasing and decreasing latitude detection.
UpdatableFrame - Class in org.orekit.frames
Frame whose transform from its parent can be updated.
UpdatableFrame(Frame, Transform, String) - Constructor for class org.orekit.frames.UpdatableFrame
Build a non-inertial frame from its transform with respect to its parent.
UpdatableFrame(Frame, Transform, String, boolean) - Constructor for class org.orekit.frames.UpdatableFrame
Build a frame from its transform with respect to its parent.
updateCoefficientsCandS(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.AbstractTides
Update the C and the S coefficients for acceleration computation.
updateCoefficientsCandS(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.OceanTides
Update the C and the S coefficients for acceleration computation.
updateCoefficientsCandS(AbsoluteDate) - Method in interface org.orekit.forces.gravity.tides.PotentialTimeVariations
Update the C and the S coefficients for acceleration computation.
updateCoefficientsCandS(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.TerrestrialTides
Update the C and the S coefficients for acceleration computation.
updateCoefficientsCandS(AbsoluteDate) - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Update the C and the S coefficients for acceleration computation.
updateCoefficientsCandSPD(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.AbstractTides
Update the C and the S coefficients for partial derivatives computation.
updateCoefficientsCandSPD(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.OceanTides
Update the C and the S coefficients for partial derivatives computation.
updateCoefficientsCandSPD(AbsoluteDate) - Method in interface org.orekit.forces.gravity.tides.PotentialTimeVariations
Update the C and the S coefficients for partial derivatives computation.
updateCoefficientsCandSPD(AbsoluteDate) - Method in class org.orekit.forces.gravity.tides.TerrestrialTides
Update the C and the S coefficients for partial derivatives computation.
updateCoefficientsCandSPD(AbsoluteDate) - Method in class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Update the C and the S coefficients for partial derivatives computation.
updateEccentricityInterval(Orbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.TesseralQuad
Update eccentricity interval [ec - Δe; ec + Δe].
updateFrame(Transform) - Method in interface fr.cnes.sirius.patrius.assembly.IPart
 
updateFrame(Transform) - Method in class fr.cnes.sirius.patrius.assembly.MainPart
 
updateFrame(Transform) - Method in class fr.cnes.sirius.patrius.assembly.Part
 
updateHighOrderDerivativesPhase1(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Update the high order scaled derivatives for Adams integrators (phase 1).
updateHighOrderDerivativesPhase1(Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Update the high order scaled derivatives for Adams integrators (phase 1).
updateHighOrderDerivativesPhase2(double[], double[], Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsIntegrator
Update the high order scaled derivatives Adams integrators (phase 2).
updateHighOrderDerivativesPhase2(double[], double[], Array2DRowRealMatrix) - Method in class org.apache.commons.math3.ode.nonstiff.AdamsNordsieckTransformer
Update the high order scaled derivatives Adams integrators (phase 2).
updateIntertiaMatrix(Matrix3D) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
Updates the inertia matrix.
updateJacobian() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1. Please use AbstractLeastSquaresOptimizer.computeWeightedJacobian(double[]) instead.
updateMainPartFrame(Transform) - Method in class fr.cnes.sirius.patrius.assembly.Assembly
Updates the main part frame's transformation to its parent frame using a Transform as an input argument.
updateMainPartFrame(SpacecraftState) - Method in class fr.cnes.sirius.patrius.assembly.Assembly
Updates the main part frame's transformation to its parent frame using a Transform as an input argument.
updateMass(String, double) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaComputedModel
Update the mass of the given part.
updateMass(String, double) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
Update the mass of the given part.
updateMass(String, double) - Method in class fr.cnes.sirius.patrius.assembly.models.MassModel
Update the mass of the given part.
updateMass(double) - Method in class fr.cnes.sirius.patrius.assembly.properties.MassProperty
Updates the mass of the part.
updateMass(double) - Method in class org.orekit.forces.maneuvers.SmallManeuverAnalyticalModel
Update a spacecraft mass due to maneuver.
updateMass(String, double) - Method in interface org.orekit.propagation.MassProvider
Update the mass of the given part.
updateMass(String, double) - Method in class org.orekit.propagation.SimpleMassModel
This model represents one part only.
updateMass(String, double) - Method in class org.orekit.propagation.SpacecraftState
Update the mass of the given part.
updateMassCenter(Vector3D) - Method in class fr.cnes.sirius.patrius.assembly.models.InertiaSimpleModel
Updates the mass center.
updateOrbit(Orbit) - Method in class org.orekit.propagation.SpacecraftState
Update the orbit.
updateQuads(Orbit) - Method in class fr.cnes.sirius.patrius.stela.forces.gravity.StelaTesseralAttraction
Compute quads (n, m, p, q).
updateResidualsAndCost() - Method in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1. Please use AbstractLeastSquaresOptimizer.computeResiduals(double[]), BaseAbstractMultivariateVectorOptimizer.computeObjectiveValue(double[]), AbstractLeastSquaresOptimizer.computeCost(double[]) and AbstractLeastSquaresOptimizer.setCost(double) instead.
updateSecularOrbit(Orbit) - Method in class org.orekit.propagation.analytical.AbstractLyddanePropagator
Update for secular Orbit.
updateSpacecraftState(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.events.sensor.SecondarySpacecraft
Updates the assembly frames at a given date from the orbit and attitude information provided by the propagator.
updateStencil() - Method in class org.apache.commons.math3.utils.RecordSegmentSearchIndex
The search algorithm is based on a four-point stencil.
updateStepCounter() - Method in class fr.cnes.sirius.patrius.stela.propagation.StelaPartialDerivativesEquations
update step counter
updateTransform(AbsoluteDate, Frame) - Static method in class fr.cnes.sirius.patrius.stela.bodies.MeeusMoonStela
Update cached transform from FramesFactory.getMOD(boolean) to provided frame.
updateTransform(AbsoluteDate, Frame) - Static method in class fr.cnes.sirius.patrius.stela.bodies.MeeusSunStela
Update cached transform from FramesFactory.getMOD(boolean) to provided frame.
updateTransform(Frame, Frame, Transform, AbsoluteDate) - Method in class org.orekit.frames.UpdatableFrame
Update the transform from parent frame implicitly according to two other frames.
UpdatingMultipleLinearRegression - Interface in org.apache.commons.math3.stat.regression
An interface for regression models allowing for dynamic updating of the data.
upperCumulativeProbability(int) - Method in class org.apache.commons.math3.distribution.HypergeometricDistribution
For this distribution, X, this method returns P(X >= x).
UPSIDE_VARIANCE - Static variable in class org.apache.commons.math3.stat.descriptive.moment.SemiVariance
The UPSIDE Direction is used to specify that the observations above the cutoff point will be used to calculate SemiVariance.
URANUS - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Uranus.
US76 - Class in org.orekit.forces.atmospheres
This class implements the US76 atmospheric model.
US76(BodyShape) - Constructor for class org.orekit.forces.atmospheres.US76
Simple constructor for class US76
useEopData() - Method in class org.orekit.frames.configuration.PolarMotion
Use EOP pole correction data.
useEopData() - Method in class org.orekit.frames.configuration.PrecessionNutation
Use EOP data for nutation correction.
UserCelestialBody - Class in fr.cnes.sirius.validate.mocks.ephemeris
User-made Celestial body.
UserCelestialBody(IEphemerisBody, IUserEphemeris) - Constructor for class fr.cnes.sirius.validate.mocks.ephemeris.UserCelestialBody
Constructor.
UserCelestialBody(IEphemerisBody, IUserEphemeris, FramesConfiguration) - Constructor for class fr.cnes.sirius.validate.mocks.ephemeris.UserCelestialBody
Constructor with frame configuration.
UserEphemeris - Class in fr.cnes.sirius.validate.mocks.ephemeris
 
UserEphemeris(String, DateComponents, TimeScale, Frame) - Constructor for class fr.cnes.sirius.validate.mocks.ephemeris.UserEphemeris
Constructor.
USKLoader - Class in fr.cnes.sirius.patrius.signalpropagation.iono
Reader for the USK data file (file of the "NEWUSK" type).
USKLoader(String) - Constructor for class fr.cnes.sirius.patrius.signalpropagation.iono.USKLoader
Creates a USK data file reader and load the file.
USKProvider - Interface in fr.cnes.sirius.patrius.signalpropagation.iono
Interface for the providers of USK data for the Bent ionospheric correction.
UT1Scale - Class in org.orekit.time
Universal Time 1.
UTCScale - Class in org.orekit.time
Coordinated Universal Time.
UTCTAILoader - Interface in org.orekit.time
Interface for loading UTC-TAI offsets data files.
UtilsCommonsMath - Class in org.apache.commons.math3
 
UtilsPatrius - Class in fr.cnes.sirius.patrius
Epsilon constants

V

v - Variable in class org.apache.commons.math3.random.AbstractWell
Bytes pool.
Validate - Class in fr.cnes.sirius.validate.validationTool
The purpose of this class is to automate the logging of deviations in order to see their evolution.
Validate(Class<?>) - Constructor for class fr.cnes.sirius.validate.validationTool.Validate
constructor of the Validate object.
validateCovarianceData(double[][], double[][]) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Validates that the x data and covariance matrix have the same number of rows and that the covariance matrix is square.
validateSampleData(double[][], double[]) - Method in class org.apache.commons.math3.stat.regression.AbstractMultipleLinearRegression
Validates sample data.
validFrom() - Method in class org.orekit.models.earth.GeoMagneticField
Returns the start of the validity period for this model.
validTo() - Method in class org.orekit.models.earth.GeoMagneticField
Returns the end of the validity period for this model.
value(double) - Method in class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
 
value(double, double) - Method in interface org.apache.commons.math3.analysis.BivariateFunction
Compute the value for the function.
value(double[]) - Method in class org.apache.commons.math3.analysis.differentiation.GradientFunction
Compute the value for the function at the given point.
value(double[]) - Method in class org.apache.commons.math3.analysis.differentiation.JacobianFunction
Compute the value for the function at the given point.
value(DerivativeStructure[]) - Method in interface org.apache.commons.math3.analysis.differentiation.MultivariateDifferentiableFunction
Compute the value for the function at the given point.
value(DerivativeStructure[]) - Method in interface org.apache.commons.math3.analysis.differentiation.MultivariateDifferentiableVectorFunction
Compute the value for the function at the given point.
value(DerivativeStructure) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateDifferentiableFunction
Simple mathematical function.
value(DerivativeStructure) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateDifferentiableMatrixFunction
Compute the value for the function.
value(DerivativeStructure) - Method in interface org.apache.commons.math3.analysis.differentiation.UnivariateDifferentiableVectorFunction
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Abs
Compute the value of the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Acos
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Acos
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Acosh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Acosh
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Add
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Asin
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Asin
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Asinh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Asinh
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Atan
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Atan
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Atan2
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Atanh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Atanh
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Cbrt
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Cbrt
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Ceil
Compute the value of the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Constant
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Constant
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Cos
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Cos
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Cosh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Cosh
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Divide
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Exp
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Exp
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Expm1
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Expm1
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Floor
Compute the value of the function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Gaussian.Parametric
Computes the value of the Gaussian at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.Gaussian
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Gaussian
Simple mathematical function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator.Parametric
Computes the value of the harmonic oscillator at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.HarmonicOscillator
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Identity
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Identity
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Inverse
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Inverse
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Log
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Log
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Log10
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Log10
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Log1p
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Log1p
Simple mathematical function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logistic.Parametric
Computes the value of the sigmoid at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.Logistic
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Logistic
Simple mathematical function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Logit.Parametric
Computes the value of the logit at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.Logit
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Logit
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Max
Compute the value for the function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Min
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Minus
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Minus
Simple mathematical function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Multiply
Compute the value for the function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Pow
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Power
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Power
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Rint
Compute the value of the function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.function.Sigmoid.Parametric
Computes the value of the sigmoid at x.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sigmoid
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sigmoid
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Signum
Compute the value of the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sin
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sin
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sinc
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sinc
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sinh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sinh
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Sqrt
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Sqrt
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.StepFunction
Compute the value of the function.
value(double, double) - Method in class org.apache.commons.math3.analysis.function.Subtract
Compute the value for the function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Tan
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Tan
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Tanh
Compute the value of the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.function.Tanh
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.function.Ulp
Compute the value of the function.
value(T) - Method in interface org.apache.commons.math3.analysis.IDependentVariable
Compute the value of the T-dependent variable.
value(T) - Method in interface org.apache.commons.math3.analysis.IDependentVectorVariable
Compute the value of the T-dependent 3D vector.
value(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BicubicSplineInterpolatingFunction
Compute the value for the function.
value(double, double) - Method in class org.apache.commons.math3.analysis.interpolation.BiLinearIntervalsFunction
Computation of the interpolated/extrapolated value f(x,y).
value(double) - Method in class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Interpolate value at a specified abscissa.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.interpolation.HermiteInterpolator
Interpolate value at a specified abscissa.
value(double[]) - Method in class org.apache.commons.math3.analysis.interpolation.MicrosphereInterpolatingFunction
 
value(double, double, double) - Method in class org.apache.commons.math3.analysis.interpolation.TricubicSplineInterpolatingFunction
Compute the value for the function.
value(double, double, double) - Method in class org.apache.commons.math3.analysis.interpolation.TriLinearIntervalsFunction
Computation of the interpolated/extrapolated value f(x,y,z).
value(double) - Method in class org.apache.commons.math3.analysis.interpolation.UniLinearIntervalsFunction
Computation of the interpolated/extrapolated value f(x).
value(double[]) - Method in interface org.apache.commons.math3.analysis.MultivariateFunction
Compute the value for the function at the given point.
value(double[]) - Method in interface org.apache.commons.math3.analysis.MultivariateMatrixFunction
Compute the value for the function at the given point.
value(double[]) - Method in interface org.apache.commons.math3.analysis.MultivariateVectorFunction
Compute the value for the function at the given point.
value(double, double...) - Method in interface org.apache.commons.math3.analysis.ParametricUnivariateFunction
Compute the value of the function.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Return value at x of polynomial.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.polynomials.FourierSeries
Simple mathematical function.
value(double, double...) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction.Parametric
Compute the value of the function.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Compute the value of the function for the given argument.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunction
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Calculate the function value at the given point.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Calculate the function value at the given point.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Compute the value for the function.
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialSplineFunction
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Return value at x of polynomial
value(int, double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Return value at x of nth order derivative
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialFunction
Simple mathematical function.
value(double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get value at given abscissa
value(int, double) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Get value of derivative
value(DerivativeStructure) - Method in class org.apache.commons.math3.analysis.polynomials.TrigonometricPolynomialPrimitive
Simple mathematical function.
value(double, double, double) - Method in interface org.apache.commons.math3.analysis.TrivariateFunction
Compute the value for the function.
value(double) - Method in interface org.apache.commons.math3.analysis.UnivariateFunction
Compute the value of the function.
value(double) - Method in interface org.apache.commons.math3.analysis.UnivariateMatrixFunction
Compute the value for the function.
value(double) - Method in interface org.apache.commons.math3.analysis.UnivariateVectorFunction
Compute the value for the function.
value(Dfp) - Method in interface org.apache.commons.math3.dfp.UnivariateDfpFunction
Compute the value of the function.
value(double[]) - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
Computes the value of the linear equation at the current point.
value(RealVector) - Method in class org.apache.commons.math3.optim.linear.LinearObjectiveFunction
Computes the value of the linear equation at the current point.
value(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.LeastSquaresConverter
Compute the value for the function at the given point.
value(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
Compute the underlying function value from an unbounded point.
value(double[]) - Method in class org.apache.commons.math3.optim.nonlinear.scalar.MultivariateFunctionPenaltyAdapter
Computes the underlying function value from an unbounded point.
value(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionMappingAdapter
Deprecated. Compute the underlying function value from an unbounded point.
value(double[]) - Method in class org.apache.commons.math3.optimization.direct.MultivariateFunctionPenaltyAdapter
Deprecated. Compute the underlying function value from an unbounded point.
value(double[]) - Method in class org.apache.commons.math3.optimization.LeastSquaresConverter
Deprecated. Compute the value for the function at the given point.
value() - Method in class org.apache.commons.math3.util.OpenIntToDoubleHashMap.Iterator
Get the value of current entry.
value() - Method in class org.apache.commons.math3.util.OpenIntToFieldHashMap.Iterator
Get the value of current entry.
value(double) - Method in class org.orekit.attitudes.kinematics.AbstractOrientationFunction
Compute the quaternion components of the orientation at the (zero + x) date.
value(double) - Method in class org.orekit.attitudes.kinematics.AbstractVector3DFunction
Compute the components of the vector at the (zero + x) date.
value(double, BodiesElements) - Method in class org.orekit.data.PoissonSeries
Compute the value of the development for the current date.
value(double, BodiesElements, BodiesElements) - Method in class org.orekit.data.PoissonSeries
Compute the value of the development for the current date and its first time derivative.
value(BodiesElements) - Method in class org.orekit.data.SeriesTerm
Compute the value of the term for the current date.
value(BodiesElements, BodiesElements) - Method in class org.orekit.data.SeriesTerm
Compute the value of the term for the current date and its first time derivative.
value(SpacecraftState) - Method in class org.orekit.parameter.ConstantFunction
Getting the value of the function.
value() - Method in class org.orekit.parameter.ConstantFunction
Value of the parameter.
value(SpacecraftState) - Method in interface org.orekit.parameter.IParameterizableFunction
Getting the value of the function.
value(SpacecraftState) - Method in class org.orekit.parameter.LinearFunction
Getting the value of the function.
value(SpacecraftState) - Method in class org.orekit.parameter.PiecewiseFunction
Getting the value of the function.
value(AbsoluteDate) - Method in class org.orekit.propagation.analytical.twod.DateIntervalLinearFunction
Returns value of function at provided date.
value(AbsoluteDate) - Method in class org.orekit.propagation.analytical.twod.DateIntervalParabolicFunction
Returns value of function at provided date.
value(AbsoluteDate) - Method in class org.orekit.propagation.analytical.twod.DatePolynomialFunction
Returns value of function at provided date.
value(AbsoluteDate) - Method in interface org.orekit.propagation.analytical.twod.UnivariateDateFunction
Returns value of function at provided date.
value(double) - Method in class org.orekit.utils.HermiteInterpolator
Interpolate value at a specified abscissa.
valueIndex(int, double) - Method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Calculate the function value at the given point.
valueOf(String) - Static method in enum fr.cnes.sirius.patrius.assembly.PropertyType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.patrius.exception.util.PatriusMessages
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.patrius.fieldsofview.BooleanField.BooleanCombination
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.patrius.projections.EnumLineProperty
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.patrius.signalpropagation.SignalPropagationModel.FixedDate
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.patrius.tools.ephemerisComparator.AllowedFileType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.patrius.tools.ephemerisComparator.DataType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.patrius.tools.exception.util.ToolsMessages
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.validate.jqnum.JQNUMTools.Rule
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.validate.jqnum.JQNUMTools.TypeStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum fr.cnes.sirius.validate.mocks.ephemeris.EphemerisBody
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.analysis.polynomials.ElementaryMultiplicationTypes.ElementaryType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.analysis.solvers.AllowedSolution
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.analysis.solvers.BaseSecantSolver.Method
Returns the enum constant of this type with the specified name.
valueOf(double, double) - Static method in class org.apache.commons.math3.complex.Complex
Create a complex number given the real and imaginary parts.
valueOf(double) - Static method in class org.apache.commons.math3.complex.Complex
Create a complex number given only the real part.
valueOf(String) - Static method in enum org.apache.commons.math3.dfp.DfpField.RoundingMode
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.exception.util.LocalizedFormats
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.geometry.euclidean.twod.EnumPolygon
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor.Order
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.geometry.partitioning.Region.Location
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.geometry.partitioning.Side
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.linear.SymmetricMatrix.SYMMETRIC
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ode.events.EventHandler.Action
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerMode
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optim.linear.Relationship
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optim.nonlinear.scalar.GoalType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optimization.general.ConjugateGradientFormula
Deprecated. Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optimization.GoalType
Deprecated. Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.optimization.linear.Relationship
Deprecated. Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.descriptive.moment.SemiVariance.Direction
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.ranking.NaNStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.stat.ranking.TiesStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.transform.DctNormalization
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.transform.DftNormalization
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.transform.DstNormalization
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.transform.TransformType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.util.MathArrays.OrderDirection
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.util.ResizableDoubleArray.ExpansionMode
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math3.utils.ISearchIndex.SearchIndexIntervalConvention
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.attitudes.ConstantSpinSlew.Constraint
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.attitudes.kinematics.KinematicsToolkit.IntegrationType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.attitudes.RelativeTabulatedAttitudeLaw.AroundAttitudeType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.bodies.JPLEphemeridesLoader.EphemerisType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.errors.OrekitAddonsMessages
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.errors.OrekitMessages
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.files.general.OrbitFile.TimeSystem
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.files.sp3.SP3File.SP3FileType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.files.sp3.SP3File.SP3OrbitType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation.StrengthLevel
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.forces.gravity.EarthGravitationalModelFactory.GravityFieldNames
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.forces.gravity.tides.TidesStandards.TidesStandard
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.frames.configuration.eop.EOPEntry.DtType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.frames.configuration.eop.EOPInterpolators
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.frames.configuration.precessionnutation.PrecessionNutationConvention
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.frames.LOFType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.frames.Predefined
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.models.earth.GeoMagneticFieldFactory.FieldModel
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.orbits.OrbitType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.orbits.PositionAngle
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.propagation.analytical.AbstractLyddanePropagator.LyddaneParametersType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.propagation.events.EventDetector.Action
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector.BodyOrder
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.propagation.events.ThreeBodiesAngleDetector.BodyOrder
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.propagation.numerical.AttitudeEquation.AttitudeType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.propagation.ParametersType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.time.Month
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.utils.AngularDerivativesFilter
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.utils.CartesianDerivativesFilter
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.orekit.utils.IntervalEndpointType
Returns the enum constant of this type with the specified name.
values() - Static method in enum fr.cnes.sirius.patrius.assembly.PropertyType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.patrius.exception.util.PatriusMessages
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.patrius.fieldsofview.BooleanField.BooleanCombination
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.patrius.projections.EnumLineProperty
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.patrius.signalpropagation.SignalPropagationModel.FixedDate
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.patrius.tools.ephemerisComparator.AllowedFileType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.patrius.tools.ephemerisComparator.DataType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.patrius.tools.exception.util.ToolsMessages
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.validate.jqnum.JQNUMTools.Rule
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.validate.jqnum.JQNUMTools.TypeStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum fr.cnes.sirius.validate.mocks.ephemeris.EphemerisBody
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.analysis.polynomials.ElementaryMultiplicationTypes.ElementaryType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.analysis.solvers.AllowedSolution
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.analysis.solvers.BaseSecantSolver.Method
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.dfp.DfpField.RoundingMode
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.exception.util.LocalizedFormats
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.geometry.euclidean.twod.EnumPolygon
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor.Order
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.geometry.partitioning.Region.Location
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.geometry.partitioning.Side
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.linear.SymmetricMatrix.SYMMETRIC
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ode.events.EventHandler.Action
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerBounds
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.ode.sampling.StepNormalizerMode
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optim.linear.Relationship
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optim.nonlinear.scalar.GoalType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optimization.general.ConjugateGradientFormula
Deprecated. Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optimization.GoalType
Deprecated. Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.optimization.linear.Relationship
Deprecated. Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.descriptive.moment.SemiVariance.Direction
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.ranking.NaNStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.stat.ranking.TiesStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.transform.DctNormalization
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.transform.DftNormalization
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.transform.DstNormalization
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.transform.TransformType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.util.MathArrays.OrderDirection
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.util.ResizableDoubleArray.ExpansionMode
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math3.utils.ISearchIndex.SearchIndexIntervalConvention
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.attitudes.ConstantSpinSlew.Constraint
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.attitudes.kinematics.KinematicsToolkit.IntegrationType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.attitudes.RelativeTabulatedAttitudeLaw.AroundAttitudeType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.bodies.JPLEphemeridesLoader.EphemerisType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.errors.OrekitAddonsMessages
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.errors.OrekitMessages
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.files.general.OrbitFile.TimeSystem
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.files.sp3.SP3File.SP3FileType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.files.sp3.SP3File.SP3OrbitType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.forces.atmospheres.solarActivity.specialized.MarshallSolarActivityFutureEstimation.StrengthLevel
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.forces.gravity.EarthGravitationalModelFactory.GravityFieldNames
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.forces.gravity.tides.TidesStandards.TidesStandard
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.frames.configuration.eop.EOPEntry.DtType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.frames.configuration.eop.EOPInterpolators
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.frames.configuration.precessionnutation.PrecessionNutationConvention
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.frames.LOFType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.frames.Predefined
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.models.earth.GeoMagneticFieldFactory.FieldModel
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.orbits.OrbitType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.orbits.PositionAngle
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.propagation.analytical.AbstractLyddanePropagator.LyddaneParametersType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.propagation.events.EventDetector.Action
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.propagation.events.ExtremaThreeBodiesAngleDetector.BodyOrder
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.propagation.events.ThreeBodiesAngleDetector.BodyOrder
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.propagation.numerical.AttitudeEquation.AttitudeType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.propagation.ParametersType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.time.Month
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.utils.AngularDerivativesFilter
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.utils.CartesianDerivativesFilter
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.orekit.utils.IntervalEndpointType
Returns an array containing the constants of this enum type, in the order they are declared.
ValueServer - Class in org.apache.commons.math3.random
Generates values for use in simulation applications.
ValueServer() - Constructor for class org.apache.commons.math3.random.ValueServer
Creates new ValueServer
ValueServer(RandomDataImpl) - Constructor for class org.apache.commons.math3.random.ValueServer
Deprecated. use ValueServer.ValueServer(RandomGenerator)
ValueServer(RandomGenerator) - Constructor for class org.apache.commons.math3.random.ValueServer
Construct a ValueServer instance using a RandomGenerator as its source of random data.
valuesIterator() - Method in class org.apache.commons.math3.stat.Frequency
Returns an Iterator over the set of values that have been added.
VariableGravityFieldFactory - Class in org.orekit.forces.gravity.variations.coefficients
Variable gravity field coefficients factory
VariablePotentialAttractionModel - Class in org.orekit.forces.gravity.variations
This class represents a variable gravity field.
VariablePotentialAttractionModel(Frame, VariablePotentialCoefficientsProvider, int, int, int, int) - Constructor for class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Variable gravity field force model constructor (static part only).
VariablePotentialAttractionModel(Frame, VariablePotentialCoefficientsProvider, int, int) - Constructor for class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Variable gravity field force model constructor (static part only).
VariablePotentialAttractionModel(Frame, VariablePotentialCoefficientsProvider, int, int, int, int, int, int, int, int, boolean) - Constructor for class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Variable gravity field force model constructor.
VariablePotentialAttractionModel(Frame, VariablePotentialCoefficientsProvider, int, int, int, int, boolean) - Constructor for class org.orekit.forces.gravity.variations.VariablePotentialAttractionModel
Variable gravity field force model constructor.
VariablePotentialCoefficientsProvider - Interface in org.orekit.forces.gravity.variations.coefficients
Interface used to provide gravity field coefficients.
VariablePotentialCoefficientsReader - Class in org.orekit.forces.gravity.variations.coefficients
Abstract class representing a variable potential coefficients file reader.
VariablePotentialCoefficientsReader(String) - Constructor for class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsReader
Simple constructor.
VariablePotentialCoefficientsSet - Class in org.orekit.forces.gravity.variations.coefficients
Represents a variable potential coefficients set for a given degree and order
VariablePotentialCoefficientsSet(int, int, double, double, double[], double[]) - Constructor for class org.orekit.forces.gravity.variations.coefficients.VariablePotentialCoefficientsSet
Create a set for a given order and degree
VariableStepAttitudeEphemerisGenerator - Class in org.orekit.attitudes
This class handles the generation of attitude ephemeris from an attitude laws sequence AttitudeLegsSequence, using a variable time step.
The ephemeris generation can be done setting the generation time interval (the default value is the time interval of the sequence), and the treatment to apply to the transition points of the sequence (ignore them, compute the attitude of the initial date of the laws, compute the attitude of the initial and final date of the laws).
VariableStepAttitudeEphemerisGenerator(AttitudeLegsSequence, double, double, double) - Constructor for class org.orekit.attitudes.VariableStepAttitudeEphemerisGenerator
Builds an attitude ephemeris generator using a variable time step and ignoring the attitude law transition points of the sequence.
VariableStepAttitudeEphemerisGenerator(AttitudeLegsSequence, double, double, double, int) - Constructor for class org.orekit.attitudes.VariableStepAttitudeEphemerisGenerator
Builds an attitude ephemeris generator using a variable time step and choosing the treatment to apply to the transition points of the sequence.
VariableThrustManeuver - Class in org.orekit.forces.maneuvers
This class implements a maneuver using variable thrust and ISP.
VariableThrustManeuver(AbsoluteDate, double, IDependentVariable<SpacecraftState>, IDependentVariable<SpacecraftState>, IDependentVectorVariable<SpacecraftState>, MassProvider, String) - Constructor for class org.orekit.forces.maneuvers.VariableThrustManeuver
Constructor for a variable direction in spacecraft frame, thrust and ISP.
VariableThrustManeuver(AbsoluteDate, double, IDependentVariable<SpacecraftState>, IDependentVariable<SpacecraftState>, IDependentVectorVariable<SpacecraftState>, MassProvider, String, Frame) - Constructor for class org.orekit.forces.maneuvers.VariableThrustManeuver
Constructor for a variable direction in provided frame, thrust and ISP.
VariableThrustManeuver(AbsoluteDate, double, IDependentVariable<SpacecraftState>, IDependentVariable<SpacecraftState>, IDependentVectorVariable<SpacecraftState>, MassProvider, String, LOFType) - Constructor for class org.orekit.forces.maneuvers.VariableThrustManeuver
Constructor for a variable direction in provided local orbital frame, thrust and ISP expressed in a LocalOrbitalFrame.
VariableThrustManeuver(EventDetector, EventDetector, IDependentVariable<SpacecraftState>, IDependentVariable<SpacecraftState>, IDependentVectorVariable<SpacecraftState>, MassProvider, String) - Constructor for class org.orekit.forces.maneuvers.VariableThrustManeuver
Constructor for a variable direction in spacecraft frame, thrust and ISP.
VariableThrustManeuver(EventDetector, EventDetector, IDependentVariable<SpacecraftState>, IDependentVariable<SpacecraftState>, IDependentVectorVariable<SpacecraftState>, MassProvider, String, Frame) - Constructor for class org.orekit.forces.maneuvers.VariableThrustManeuver
Constructor for a variable direction in provided frame, thrust and ISP.
VariableThrustManeuver(EventDetector, EventDetector, IDependentVariable<SpacecraftState>, IDependentVariable<SpacecraftState>, IDependentVectorVariable<SpacecraftState>, MassProvider, String, LOFType) - Constructor for class org.orekit.forces.maneuvers.VariableThrustManeuver
Constructor for a variable direction in provided local orbital frame, thrust and ISP expressed in a LocalOrbitalFrame.
Variance - Class in org.apache.commons.math3.stat.descriptive.moment
Computes the variance of the available values.
Variance() - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Constructs a Variance with default (true) isBiasCorrected property.
Variance(SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Constructs a Variance based on an external second moment.
Variance(boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Constructs a Variance with the specified isBiasCorrected property
Variance(boolean, SecondMoment) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Constructs a Variance with the specified isBiasCorrected property and the supplied external second moment.
Variance(Variance) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.Variance
Copy constructor, creates a new Variance identical to the original
variance(double[]) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the entries in the input array, or Double.NaN if the array is empty.
variance(double[], int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
variance(double[], double, int, int) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
variance(double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the entries in the input array, using the precomputed mean value.
varianceDifference(double[], double[], double) - Static method in class org.apache.commons.math3.stat.StatUtils
Returns the variance of the (signed) differences between corresponding elements of the input arrays -- i.e., var(sample1[i] - sample2[i]).
vecAbsoluteTolerance - Variable in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Allowed absolute vectorial error.
vecRelativeTolerance - Variable in class org.apache.commons.math3.ode.nonstiff.AdaptiveStepsizeIntegrator
Allowed relative vectorial error.
Vector<S extends Space> - Interface in org.apache.commons.math3.geometry
This interface represents a generic vector in a vectorial space or a point in an affine space.
VECTOR - Static variable in class org.apache.commons.math3.linear.ConjugateGradient
Key for the exception context.
Vector1D - Class in org.apache.commons.math3.geometry.euclidean.oned
This class represents a 1D vector.
Vector1D(double) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Simple constructor.
Vector1D(double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Multiplicative constructor Build a vector from another one and a scale factor.
Vector1D(double, Vector1D, double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Linear constructor Build a vector from two other ones and corresponding scale factors.
Vector1D(double, Vector1D, double, Vector1D, double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Linear constructor Build a vector from three other ones and corresponding scale factors.
Vector1D(double, Vector1D, double, Vector1D, double, Vector1D, double, Vector1D) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Linear constructor Build a vector from four other ones and corresponding scale factors.
Vector1DFormat - Class in org.apache.commons.math3.geometry.euclidean.oned
Formats a 1D vector in components list format "{x}".
Vector1DFormat() - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Create an instance with default settings.
Vector1DFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Create an instance with a custom number format for components.
Vector1DFormat(String, String) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Create an instance with custom prefix, suffix and separator.
Vector1DFormat(String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.oned.Vector1DFormat
Create an instance with custom prefix, suffix, separator and format for components.
Vector2D - Class in org.apache.commons.math3.geometry.euclidean.twod
This class represents a 2D vector.
Vector2D(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Simple constructor.
Vector2D(double[]) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Simple constructor.
Vector2D(double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Multiplicative constructor Build a vector from another one and a scale factor.
Vector2D(double, Vector2D, double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Linear constructor Build a vector from two other ones and corresponding scale factors.
Vector2D(double, Vector2D, double, Vector2D, double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Linear constructor Build a vector from three other ones and corresponding scale factors.
Vector2D(double, Vector2D, double, Vector2D, double, Vector2D, double, Vector2D) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Linear constructor Build a vector from four other ones and corresponding scale factors.
Vector2DFormat - Class in org.apache.commons.math3.geometry.euclidean.twod
Formats a 2D vector in components list format "{x; y}".
Vector2DFormat() - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Create an instance with default settings.
Vector2DFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Create an instance with a custom number format for components.
Vector2DFormat(String, String, String) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Create an instance with custom prefix, suffix and separator.
Vector2DFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.twod.Vector2DFormat
Create an instance with custom prefix, suffix, separator and format for components.
Vector3D - Class in org.apache.commons.math3.geometry.euclidean.threed
This class implements vectors in a three-dimensional space.
Vector3D(double, double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Simple constructor.
Vector3D(double[]) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Simple constructor.
Vector3D(double, double) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Simple constructor.
Vector3D(double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Multiplicative constructor Build a vector from another one and a scale factor.
Vector3D(double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
Vector3D(double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
Vector3D(double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
Vector3D(RealVector) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
From a RealVector constructor Build a vector from a RealVector object.
Vector3DFormat - Class in org.apache.commons.math3.geometry.euclidean.threed
Formats a 3D vector in components list format "{x; y; z}".
Vector3DFormat() - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Create an instance with default settings.
Vector3DFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Create an instance with a custom number format for components.
Vector3DFormat(String, String, String) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Create an instance with custom prefix, suffix and separator.
Vector3DFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.euclidean.threed.Vector3DFormat
Create an instance with custom prefix, suffix, separator and format for components.
Vector3DFunction - Interface in org.orekit.attitudes.kinematics
This interface is a time-dependent function representing a generic vector 3D.
Vector3DPolynomialSegment - Class in fr.cnes.sirius.patrius.guidance
This class represents an angular velocity polynomial guidance profile on a segment.
Vector3DPolynomialSegment(PolynomialFunctionLagrangeForm, PolynomialFunctionLagrangeForm, PolynomialFunctionLagrangeForm, AbsoluteDate, AbsoluteDateInterval) - Constructor for class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
Build an angular velocity polynomial guidance profile on a segment.
The polynomial representing the vector 3D components are on lagrange form.
Vector3DPolynomialSegment(PolynomialFunction, PolynomialFunction, PolynomialFunction, AbsoluteDate, AbsoluteDateInterval) - Constructor for class fr.cnes.sirius.patrius.guidance.Vector3DPolynomialSegment
Build an angular velocity polynomial guidance profile on a segment.
The polynomial representing the vector 3D components are generic polynomial functions.
VectorDPFacade - Class in fr.cnes.sirius.patrius.tools.ephemerisComparator
This class is a facade for the use of vectors.
VectorDPFacade(double[]) - Constructor for class fr.cnes.sirius.patrius.tools.ephemerisComparator.VectorDPFacade
simple constructor.
VectorFormat<S extends Space> - Class in org.apache.commons.math3.geometry
Formats a vector in components list format "{x; y; ...}".
VectorFormat() - Constructor for class org.apache.commons.math3.geometry.VectorFormat
Create an instance with default settings.
VectorFormat(NumberFormat) - Constructor for class org.apache.commons.math3.geometry.VectorFormat
Create an instance with a custom number format for components.
VectorFormat(String, String, String) - Constructor for class org.apache.commons.math3.geometry.VectorFormat
Create an instance with custom prefix, suffix and separator.
VectorFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math3.geometry.VectorFormat
Create an instance with custom prefix, suffix, separator and format for components.
VectorialCovariance - Class in org.apache.commons.math3.stat.descriptive.moment
Returns the covariance matrix of the available vectors.
VectorialCovariance(int, boolean) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.VectorialCovariance
Constructs a VectorialCovariance.
VectorialMean - Class in org.apache.commons.math3.stat.descriptive.moment
Returns the arithmetic mean of the available vectors.
VectorialMean(int) - Constructor for class org.apache.commons.math3.stat.descriptive.moment.VectorialMean
Constructs a VectorialMean.
vectorToMatrix(double[], double[][]) - Static method in class fr.cnes.sirius.patrius.stela.JavaMathAdapter
Copy a vector into a matrix, column per column.
VEISProvider - Class in org.orekit.frames.transformations
Veis 1950 Frame.
VEISProvider() - Constructor for class org.orekit.frames.transformations.VEISProvider
Constructor for the singleton.
VelocityDirection - Class in org.orekit.attitudes.directions
Direction defined for any PVCoordinatesProvider origin by its velocity vector, expressed in a reference frame (parameter of the constructor).
VelocityDirection(Frame) - Constructor for class org.orekit.attitudes.directions.VelocityDirection
Build a Direction defined for any PVCoordinatesProvider origin by its velocity vector with respect to a reference frame.
VENUS - Static variable in class org.orekit.bodies.CelestialBodyFactory
Predefined name for Venus.
verifyBracketing(double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Check that the endpoints specify an interval and the function takes opposite signs at the endpoints.
verifyBracketing(UnivariateFunction, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check that the endpoints specify an interval and the end points bracket a root.
verifyInputArray(double[], double[]) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionNewtonForm
Verifies that the input arrays are valid.
verifyInterpolationArray(double[], double[], boolean) - Static method in class org.apache.commons.math3.analysis.polynomials.PolynomialFunctionLagrangeForm
Check that the interpolation arrays are valid.
verifyInterval(double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Check that the endpoints specify an interval.
verifyInterval(double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check that the endpoints specify an interval.
verifySequence(double, double, double) - Method in class org.apache.commons.math3.analysis.solvers.BaseAbstractUnivariateSolver
Check that lower < initial < upper.
verifySequence(double, double, double) - Static method in class org.apache.commons.math3.analysis.solvers.UnivariateSolverUtils
Check that lower < initial < upper.
VisibilityFromStationDetector - Class in fr.cnes.sirius.patrius.events.sensor
Finder for satellite apparent entering in a station's field of view.
VisibilityFromStationDetector(TopocentricFrame, double[][], AngularCorrection, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
Build a new apparent elevation detector with parameterizable tropospheric correction.
VisibilityFromStationDetector(TopocentricFrame, double[][], AngularCorrection, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
Build a new apparent elevation detector with parameterizable tropospheric correction.
VisibilityFromStationDetector(TopocentricFrame, double[][], AngularCorrection, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
Build a new apparent elevation detector with parameterizable tropospheric correction.
VisibilityFromStationDetector(GeometricStationAntenna, AngularCorrection, double, double) - Constructor for class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
Build a new apparent elevation detector with parameterizable tropospheric correction.
VisibilityFromStationDetector(GeometricStationAntenna, AngularCorrection, double, double, EventDetector.Action, EventDetector.Action) - Constructor for class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
Build a new apparent elevation detector with parameterizable tropospheric correction.
VisibilityFromStationDetector(GeometricStationAntenna, AngularCorrection, double, double, EventDetector.Action, EventDetector.Action, boolean, boolean) - Constructor for class fr.cnes.sirius.patrius.events.sensor.VisibilityFromStationDetector
Build a new apparent elevation detector with parameterizable tropospheric correction.
visibilityOk(AbsoluteDate) - Method in class fr.cnes.sirius.patrius.assembly.models.SensorModel
Checks if the main target is in the field of view and no inhibition target in its inhibition field at a given date.
visit(BSPTreeVisitor<S>) - Method in class org.apache.commons.math3.geometry.partitioning.BSPTree
Visit the BSP tree nodes.
visit(int, int, T) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, T) - Method in class org.apache.commons.math3.linear.DefaultFieldMatrixPreservingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in class org.apache.commons.math3.linear.DefaultRealMatrixPreservingVisitor
Visit one matrix entry.
visit(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, T) - Method in interface org.apache.commons.math3.linear.FieldMatrixPreservingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in interface org.apache.commons.math3.linear.RealMatrixPreservingVisitor
Visit one matrix entry.
visit(int, double) - Method in interface org.apache.commons.math3.linear.RealVectorChangingVisitor
Visit one entry of the vector.
visit(int, double) - Method in interface org.apache.commons.math3.linear.RealVectorPreservingVisitor
Visit one entry of the vector.
visitInternalNode(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor
Visit a BSP tree node node having a non-null sub-hyperplane.
visitLeafNode(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor
Visit a leaf BSP tree node node having a null sub-hyperplane.
visitOrder(BSPTree<S>) - Method in interface org.apache.commons.math3.geometry.partitioning.BSPTreeVisitor
Determine the visit order for this node.

W

walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) some matrix entries in column order.
walkInDefaultOrder(RealVectorPreservingVisitor) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (but does not alter) all entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorPreservingVisitor, int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (but does not alter) some entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorChangingVisitor) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (and possibly alters) all entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorChangingVisitor, int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (and possibly alters) some entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorPreservingVisitor) - Method in class org.apache.commons.math3.linear.RealVector
Visits (but does not alter) all entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorPreservingVisitor, int, int) - Method in class org.apache.commons.math3.linear.RealVector
Visits (but does not alter) some entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorChangingVisitor) - Method in class org.apache.commons.math3.linear.RealVector
Visits (and possibly alters) all entries of this vector in default order (increasing index).
walkInDefaultOrder(RealVectorChangingVisitor, int, int) - Method in class org.apache.commons.math3.linear.RealVector
Visits (and possibly alters) some entries of this vector in default order (increasing index).
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealVectorPreservingVisitor) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (but does not alter) all entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorPreservingVisitor, int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (but does not alter) some entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorChangingVisitor) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (and possibly alters) all entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorChangingVisitor, int, int) - Method in class org.apache.commons.math3.linear.ArrayRealVector
Visits (and possibly change) some entries of this vector in optimized order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealVectorPreservingVisitor) - Method in class org.apache.commons.math3.linear.RealVector
Visits (but does not alter) all entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorPreservingVisitor, int, int) - Method in class org.apache.commons.math3.linear.RealVector
Visits (but does not alter) some entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorChangingVisitor) - Method in class org.apache.commons.math3.linear.RealVector
Visits (and possibly alters) all entries of this vector in optimized order.
walkInOptimizedOrder(RealVectorChangingVisitor, int, int) - Method in class org.apache.commons.math3.linear.RealVector
Visits (and possibly change) some entries of this vector in optimized order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractFieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.AbstractRealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowFieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.Array2DRowRealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockFieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.BlockRealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math3.linear.DiagonalMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math3.linear.FieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.apache.commons.math3.linear.RealMatrix
Visit (but don't change) some matrix entries in row order.
wasException - Variable in class fr.cnes.sirius.patrius.stela.propagation.StelaGTOPropagator
Was the exception mecanism triggered already
WeibullDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Weibull distribution.
WeibullDistribution(double, double) - Constructor for class org.apache.commons.math3.distribution.WeibullDistribution
Create a Weibull distribution with the given shape and scale and a location equal to zero.
WeibullDistribution(double, double, double) - Constructor for class org.apache.commons.math3.distribution.WeibullDistribution
Create a Weibull distribution with the given shape, scale and inverse cumulative probability accuracy and a location equal to zero.
WeibullDistribution(RandomGenerator, double, double, double) - Constructor for class org.apache.commons.math3.distribution.WeibullDistribution
Creates a Weibull distribution.
Weight - Class in org.apache.commons.math3.optim.nonlinear.vector
Weight matrix of the residuals between model and observations.
Weight(double[]) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.Weight
Creates a diagonal weight matrix.
Weight(RealMatrix) - Constructor for class org.apache.commons.math3.optim.nonlinear.vector.Weight
 
Weight - Class in org.apache.commons.math3.optimization
Deprecated. As of 3.1 (to be removed in 4.0).
Weight(double[]) - Constructor for class org.apache.commons.math3.optimization.Weight
Deprecated. Creates a diagonal weight matrix.
Weight(RealMatrix) - Constructor for class org.apache.commons.math3.optimization.Weight
Deprecated.  
WeightedEvaluation - Interface in org.apache.commons.math3.stat.descriptive
Weighted evaluation for statistics.
WeightedObservedPoint - Class in org.apache.commons.math3.fitting
This class is a simple container for weighted observed point in curve fitting.
WeightedObservedPoint(double, double, double) - Constructor for class org.apache.commons.math3.fitting.WeightedObservedPoint
Simple constructor.
WeightedObservedPoint - Class in org.apache.commons.math3.optimization.fitting
Deprecated. As of 3.1 (to be removed in 4.0).
WeightedObservedPoint(double, double, double) - Constructor for class org.apache.commons.math3.optimization.fitting.WeightedObservedPoint
Deprecated. Simple constructor.
weightedResidualJacobian - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1. To be removed in 4.0. Please use AbstractLeastSquaresOptimizer.computeWeightedJacobian(double[]) instead.
weightedResiduals - Variable in class org.apache.commons.math3.optimization.general.AbstractLeastSquaresOptimizer
Deprecated. As of 3.1.
Well1024a - Class in org.apache.commons.math3.random
This class implements the WELL1024a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well1024a() - Constructor for class org.apache.commons.math3.random.Well1024a
Creates a new random number generator.
Well1024a(int) - Constructor for class org.apache.commons.math3.random.Well1024a
Creates a new random number generator using a single int seed.
Well1024a(int[]) - Constructor for class org.apache.commons.math3.random.Well1024a
Creates a new random number generator using an int array seed.
Well1024a(long) - Constructor for class org.apache.commons.math3.random.Well1024a
Creates a new random number generator using a single long seed.
Well19937a - Class in org.apache.commons.math3.random
This class implements the WELL19937a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well19937a() - Constructor for class org.apache.commons.math3.random.Well19937a
Creates a new random number generator.
Well19937a(int) - Constructor for class org.apache.commons.math3.random.Well19937a
Creates a new random number generator using a single int seed.
Well19937a(int[]) - Constructor for class org.apache.commons.math3.random.Well19937a
Creates a new random number generator using an int array seed.
Well19937a(long) - Constructor for class org.apache.commons.math3.random.Well19937a
Creates a new random number generator using a single long seed.
Well19937c - Class in org.apache.commons.math3.random
This class implements the WELL19937c pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well19937c() - Constructor for class org.apache.commons.math3.random.Well19937c
Creates a new random number generator.
Well19937c(int) - Constructor for class org.apache.commons.math3.random.Well19937c
Creates a new random number generator using a single int seed.
Well19937c(int[]) - Constructor for class org.apache.commons.math3.random.Well19937c
Creates a new random number generator using an int array seed.
Well19937c(long) - Constructor for class org.apache.commons.math3.random.Well19937c
Creates a new random number generator using a single long seed.
Well44497a - Class in org.apache.commons.math3.random
This class implements the WELL44497a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well44497a() - Constructor for class org.apache.commons.math3.random.Well44497a
Creates a new random number generator.
Well44497a(int) - Constructor for class org.apache.commons.math3.random.Well44497a
Creates a new random number generator using a single int seed.
Well44497a(int[]) - Constructor for class org.apache.commons.math3.random.Well44497a
Creates a new random number generator using an int array seed.
Well44497a(long) - Constructor for class org.apache.commons.math3.random.Well44497a
Creates a new random number generator using a single long seed.
Well44497b - Class in org.apache.commons.math3.random
This class implements the WELL44497b pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well44497b() - Constructor for class org.apache.commons.math3.random.Well44497b
Creates a new random number generator.
Well44497b(int) - Constructor for class org.apache.commons.math3.random.Well44497b
Creates a new random number generator using a single int seed.
Well44497b(int[]) - Constructor for class org.apache.commons.math3.random.Well44497b
Creates a new random number generator using an int array seed.
Well44497b(long) - Constructor for class org.apache.commons.math3.random.Well44497b
Creates a new random number generator using a single long seed.
Well512a - Class in org.apache.commons.math3.random
This class implements the WELL512a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well512a() - Constructor for class org.apache.commons.math3.random.Well512a
Creates a new random number generator.
Well512a(int) - Constructor for class org.apache.commons.math3.random.Well512a
Creates a new random number generator using a single int seed.
Well512a(int[]) - Constructor for class org.apache.commons.math3.random.Well512a
Creates a new random number generator using an int array seed.
Well512a(long) - Constructor for class org.apache.commons.math3.random.Well512a
Creates a new random number generator using a single long seed.
WGS84_EARTH_ANGULAR_VELOCITY - Static variable in interface org.orekit.utils.Constants
Earth angular velocity from WGS84 model: 7.292115e-5 rad/s.
WGS84_EARTH_C20 - Static variable in interface org.orekit.utils.Constants
Earth un-normalized second zonal coefficient from WGS84 model: .
WGS84_EARTH_EQUATORIAL_RADIUS - Static variable in interface org.orekit.utils.Constants
Earth equatorial radius from WGS84 model: 6378137.0 m.
WGS84_EARTH_FLATTENING - Static variable in interface org.orekit.utils.Constants
Earth flattening from WGS84 model: 1.0 / 298.257223563.
WGS84_EARTH_MU - Static variable in interface org.orekit.utils.Constants
Earth gravitational constant from WGS84 model: 3.986004418 m3/s2.
wholeHyperplane() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Build a region covering the whole hyperplane.
wholeHyperplane() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a region covering the whole hyperplane.
wholeHyperplane() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Build a sub-hyperplane covering the whole hyperplane.
wholeHyperplane() - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Build a sub-hyperplane covering the whole hyperplane.
wholeLine() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Line
Build a sub-line covering the whole line.
wholeSpace() - Method in class org.apache.commons.math3.geometry.euclidean.oned.OrientedPoint
Build a region covering the whole space.
wholeSpace() - Method in class org.apache.commons.math3.geometry.euclidean.threed.Plane
Build a region covering the whole space.
wholeSpace() - Method in class org.apache.commons.math3.geometry.euclidean.twod.Line
Build a region covering the whole space.
wholeSpace() - Method in interface org.apache.commons.math3.geometry.partitioning.Hyperplane
Build a region covering the whole space.
wilcoxonSignedRank(double[], double[]) - Method in class org.apache.commons.math3.stat.inference.WilcoxonSignedRankTest
Computes the Wilcoxon signed ranked statistic comparing mean for two related samples or repeated measurements on a single sample.
WilcoxonSignedRankTest - Class in org.apache.commons.math3.stat.inference
An implementation of the Wilcoxon signed-rank test.
WilcoxonSignedRankTest() - Constructor for class org.apache.commons.math3.stat.inference.WilcoxonSignedRankTest
Create a test instance where NaN's are left in place and ties get the average of applicable ranks.
WilcoxonSignedRankTest(NaNStrategy, TiesStrategy) - Constructor for class org.apache.commons.math3.stat.inference.WilcoxonSignedRankTest
Create a test instance using the given strategies for NaN's and ties.
wilcoxonSignedRankTest(double[], double[], boolean) - Method in class org.apache.commons.math3.stat.inference.WilcoxonSignedRankTest
Returns the observed significance level, or p-value, associated with a Wilcoxon signed ranked statistic comparing mean for two related samples or repeated measurements on a single sample.
windowSize - Variable in class org.apache.commons.math3.stat.descriptive.DescriptiveStatistics
hold the window size
withReferenceFrame(Frame, boolean) - Method in class org.orekit.attitudes.Attitude
Get a similar attitude with a specific reference frame.
withReferenceFrame(Frame) - Method in class org.orekit.attitudes.Attitude
Get a similar attitude with a specific reference frame.
Wrench - Class in org.orekit.wrenches
This class represents a wrench.
Wrench(Vector3D, Vector3D, Vector3D) - Constructor for class org.orekit.wrenches.Wrench
Create a wrench with given force and torque.
Wrench(double[]) - Constructor for class org.orekit.wrenches.Wrench
Constructor from an array.
WrenchModel - Interface in org.orekit.wrenches
Interface to represents wrench models.
writeBaseExternal(ObjectOutput) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
Save the base state of the instance.
writeExternal(ObjectOutput) - Method in class org.apache.commons.math3.ode.sampling.AbstractStepInterpolator
writeExternal(ObjectOutput) - Method in class org.apache.commons.math3.ode.sampling.NordsieckStepInterpolator
writeLoggedEventsToVTS(String, String, String, String, List<EventsLogger.LoggedEvent>) - Static method in class fr.cnes.sirius.validate.files.ResultsFileWriter
Method to write a visualisation tool VTS MEM file.
writeResultsToPlot(String, String, List<double[]>) - Static method in class fr.cnes.sirius.validate.files.ResultsFileWriter
Method to write results given as an array of double of any size in organized directory.
writeResultsToVTS(String, String, String, String, List<SpacecraftState>) - Static method in class fr.cnes.sirius.validate.files.ResultsFileWriter
Method to write the attitudes and positions files used by VTS visualization tool.

X

xl - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
L from SPTRCK #3.
xmdot - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
common parameter for mean anomaly (M) computation.
xn0dp - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
original recovered mean motion.
xnodcf - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
common parameter for raan (OMEGA) computation.
xnode - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
final RAAN.
xnodot - Variable in class org.orekit.propagation.analytical.tle.TLEPropagator
common parameter for raan (OMEGA) computation.
xor(Region<S>, Region<S>) - Method in class org.apache.commons.math3.geometry.partitioning.RegionFactory
Compute the symmetric difference (exclusive or) of two regions.
xtab - Variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Abscissas array.
XYX - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.
XYZ - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
XZX - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.
XZY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.

Y

YawCompensation - Class in org.orekit.attitudes
This class handles yaw compensation attitude provider.
YawCompensation(GroundPointing) - Constructor for class org.orekit.attitudes.YawCompensation
Creates a new instance.
YawSteering - Class in org.orekit.attitudes
This class handles yaw steering law.
YawSteering(GroundPointing, PVCoordinatesProvider, Vector3D) - Constructor for class org.orekit.attitudes.YawSteering
Creates a new instance.
ytab - Variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Ordinates array.
YXY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.
YXZ - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
YZX - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
YZY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.

Z

ZERO - Static variable in class org.apache.commons.math3.complex.Complex
A complex number representing "0.0 + 0.0i"
ZERO - Static variable in class org.apache.commons.math3.complex.Quaternion
Zero quaternion.
ZERO - Static variable in class org.apache.commons.math3.fraction.BigFraction
A fraction representing "0".
ZERO - Static variable in class org.apache.commons.math3.fraction.Fraction
A fraction representing "0".
ZERO - Static variable in class org.apache.commons.math3.geometry.euclidean.oned.Vector1D
Origin (coordinates: 0).
ZERO - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.Vector3D
Null vector (coordinates: 0, 0, 0).
ZERO - Static variable in class org.apache.commons.math3.geometry.euclidean.twod.Vector2D
Origin (coordinates: 0, 0).
ZERO - Static variable in class org.apache.commons.math3.util.BigReal
A big real representing 0.
ZERO - Static variable in class org.apache.commons.math3.util.Decimal64
The constant value of 0d as a Decimal64.
ZERO - Static variable in class org.orekit.utils.CardanMountPosition
Fixed position at origin (p is zero vector).
ZERO - Static variable in class org.orekit.utils.PVCoordinates
Fixed position/velocity/acceleration at origin (both p, v and a are zero vectors).
ZERO - Static variable in class org.orekit.utils.TopocentricPosition
Fixed position at origin (p is zero vector).
ZERO - Static variable in class org.orekit.wrenches.Wrench
Zero wrench.
ZeroException - Exception in org.apache.commons.math3.exception
Exception to be thrown when zero is provided where it is not allowed.
ZeroException() - Constructor for exception org.apache.commons.math3.exception.ZeroException
Construct the exception.
ZeroException(Localizable, Object...) - Constructor for exception org.apache.commons.math3.exception.ZeroException
Construct the exception with a specific context.
ZIP_ARCHIVE_PATTERN - Static variable in interface org.orekit.data.DataProvider
Pattern for name of zip/jar archives.
ZipfDistribution - Class in org.apache.commons.math3.distribution
Implementation of the Zipf distribution.
ZipfDistribution(int, double) - Constructor for class org.apache.commons.math3.distribution.ZipfDistribution
Create a new Zipf distribution with the given number of elements and exponent.
ZipfDistribution(RandomGenerator, int, double) - Constructor for class org.apache.commons.math3.distribution.ZipfDistribution
Creates a Zipf distribution.
ZipJarCrawler - Class in org.orekit.data
Helper class for loading data files from a zip/jar archive.
ZipJarCrawler(File) - Constructor for class org.orekit.data.ZipJarCrawler
Build a zip crawler for an archive file on filesystem.
ZipJarCrawler(String) - Constructor for class org.orekit.data.ZipJarCrawler
Build a zip crawler for an archive file in classpath.
ZipJarCrawler(ClassLoader, String) - Constructor for class org.orekit.data.ZipJarCrawler
Build a zip crawler for an archive file in classpath.
ZipJarCrawler(URL) - Constructor for class org.orekit.data.ZipJarCrawler
Build a zip crawler for an archive file on network.
ztab - Variable in class org.apache.commons.math3.analysis.interpolation.AbstractLinearIntervalsFunction
Heights array.
ZXY - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
ZXZ - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.
ZYX - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Cardan angles.
ZYZ - Static variable in class org.apache.commons.math3.geometry.euclidean.threed.RotationOrder
Set of Euler angles.

A B C D E F G H I J K L M N O P Q R S T U V W X Y Z

Copyright © 2016 CNES. All Rights Reserved.