All Classes Interface Summary Class Summary Enum Summary Exception Summary Annotation Types Summary
Class |
Description |
AbsoluteDate |
This class represents a specific instant in time.
|
AbsoluteJacobiansMapper |
|
AbsolutePartialDerivativesEquations |
Deprecated.
|
AbsolutePVCoordinates |
Position - Velocity - Acceleration linked to a date and a frame.
|
AbstractAlmanac |
Base class for GNSS almanacs.
|
AbstractAmbiguityModifier |
Base class for phase ambiguity modifier.
|
AbstractAnalyticalGradientConverter |
Converter for analytical orbit propagator.
|
AbstractAnalyticalMatricesHarvester |
Base class harvester between two-dimensional Jacobian
matrices and analytical orbit propagator.
|
AbstractAnalyticalPropagator |
Common handling of Propagator methods for analytical propagators.
|
AbstractBatchLSModel |
|
AbstractBuilder<T extends AbstractBuilder<T>> |
|
AbstractConstantThrustPropulsionModel |
This abstract class simply serve as a container for a constant thrust maneuver.
|
AbstractConstituentParser<T extends NdmConstituent<?,?>,P extends AbstractConstituentParser<T,?>> |
Parser for CCSDS messages.
|
AbstractCovarianceMatrixProvider |
Abstract provider handling a predefined initial covariance matrix.
|
AbstractCycleSlipDetector |
Base class for cycle-slip detectors.
|
AbstractDetector<T extends AbstractDetector<T>> |
Common parts shared by several orbital events finders.
|
AbstractDragForceModel |
Base class for drag force models.
|
AbstractDualFrequencyCombination |
Base class for dual frequency combination of measurements.
|
AbstractEncodedMessages |
Encoded messages as a sequence of bytes.
|
AbstractEopLoader |
Base class for EOP loaders.
|
AbstractEphemerisMessage |
Base class for ephemeris-based navigation messages.
|
AbstractFieldOfView |
Abstract class representing a spacecraft sensor Field Of View.
|
AbstractForceModel |
Base class for force models.
|
AbstractFrames |
This class is an implementation of Frames that creates frames when they are
first used and uses synchronization to ensure that each frame is only created once.
|
AbstractGaussianContribution |
Common handling of DSSTForceModel methods for Gaussian contributions
to DSST propagation.
|
AbstractGaussianContribution.FieldGaussianShortPeriodicCoefficients<T extends CalculusFieldElement<T>> |
This class handles the short periodic coefficients described in Danielson
2.5.3-26.
|
AbstractGaussianContribution.FieldSlot<T extends CalculusFieldElement<T>> |
Coefficients valid for one time slot.
|
AbstractGaussianContribution.FieldUijVijCoefficients<T extends CalculusFieldElement<T>> |
The Uij and Vij coefficients
described by equations 2.5.3-(21) and 2.5.3-(22) from Danielson.
|
AbstractGaussianContribution.GaussianShortPeriodicCoefficients |
This class handles the short periodic coefficients described in Danielson
2.5.3-26.
|
AbstractGaussianContribution.GaussQuadrature |
Class used to integrate a function of the orbital elements using the Gaussian quadrature rule to get
the acceleration.
|
AbstractGaussianContribution.Slot |
Coefficients valid for one time slot.
|
AbstractGaussianContribution.UijVijCoefficients |
The Uij and Vij coefficients
described by equations 2.5.3-(21) and 2.5.3-(22) from Danielson.
|
AbstractGaussianContributionContext |
|
AbstractGenerator |
Base class for both Key-Value Notation and eXtended Markup Language generators for CCSDS messages.
|
AbstractGradientConverter |
Converter for states and parameters arrays.
|
AbstractIntegratedPropagator |
Common handling of Propagator
methods for both numerical and semi-analytical propagators.
|
AbstractIntegratedPropagator.MainStateEquations |
Differential equations for the main state (orbit, attitude and mass).
|
AbstractJacobiansMapper |
Base class for jacobian mapper.
|
AbstractKalmanEstimator |
Base class for Kalman estimators.
|
AbstractKalmanModel |
Abstract class defining the process model dynamics to use with a KalmanEstimator .
|
AbstractLambdaMethod |
Base class for decorrelation/reduction engine for LAMBDA type methods.
|
AbstractListCrawler<T> |
Provider for data files defined in a list.
|
AbstractManeuverTriggers |
Base class for triggers.
|
AbstractMatricesHarvester |
|
AbstractMeasurement<T extends ObservedMeasurement<T>> |
Abstract class handling measurements boilerplate.
|
AbstractMeasurementBuilder<T extends ObservedMeasurement<T>> |
|
AbstractMessageParser<T> |
Parser for CCSDS messages.
|
AbstractMessageWriter<H extends Header,S extends Segment<?,?>,F extends NdmConstituent<H,S>> |
Base class for Navigation Data Message (NDM) files.
|
AbstractMultipleShooting |
Multiple shooting method using only constraints on state vectors of patch points (and possibly on epoch and integration time).
|
AbstractNavigationMessage |
Base class for GNSS navigation messages.
|
AbstractPropagator |
Common handling of Propagator methods for analytical propagators.
|
AbstractPropagatorBuilder |
Base class for propagator builders.
|
AbstractPropagatorConverter |
|
AbstractRadiationForceModel |
Base class for radiation force models.
|
AbstractRelativisticClockModifier |
Class modifying theoretical measurements with relativistic clock correction.
|
AbstractRelativisticJ2ClockModifier |
Class modifying theoretical measurements with relativistic J2 clock correction.
|
AbstractScheduler<T extends ObservedMeasurement<T>> |
|
AbstractSelfFeedingLoader |
|
AbstractShapiroBaseModifier |
Class modifying theoretical range measurement with Shapiro time delay.
|
AbstractSingleFrequencyCombination |
Base class for single frequency combination of measurements.
|
AbstractTimeScales |
Abstract base class for TimeScales that implements some common functionality.
|
AbstractWriter |
Top level class for writing CCSDS message sections.
|
AccelerationModel |
Acceleration model used by empirical force.
|
AccuracyProvider |
This interface represents an accuracy providerused to validate RTCM ephemeris messages.
|
AccurateFormatter |
Formatter used to produce strings from data with high accuracy.
|
AdamsBashforthIntegratorBuilder |
Builder for AdamsBashforthIntegrator.
|
AdamsMoultonIntegratorBuilder |
Builder for AdamsMoultonIntegrator.
|
AdapterDetector |
Base class for adapting an existing detector.
|
AdapterPropagator |
|
AdapterPropagator.DifferentialEffect |
Interface for orbit differential effects.
|
AdditionalCovarianceMetadata |
Container for the additional covariance metadata (optional).
|
AdditionalCovarianceMetadataKey |
|
AdditionalDerivativesProvider |
Provider for additional derivatives.
|
AdditionalEquations |
Deprecated.
|
AdditionalEquationsAdapter |
Deprecated.
|
AdditionalParameters |
Container for additional parameters data block.
|
AdditionalParametersKey |
|
AdditionalParametersWriter |
Writer for additional parameters data block for CCSDS Conjunction Data Messages.
|
AdditionalStateProvider |
This interface represents providers for additional state data beyond SpacecraftState .
|
AdmMetadata |
This class gathers the meta-data present in the Attitude Data Message (ADM).
|
AdmMetadataKey |
|
AdmMetadataWriter |
Writer for Common metadata for CCSDS Attitude Parameter/Ephemeris Messages.
|
AdmParser<T extends NdmConstituent<?,?>,P extends AbstractConstituentParser<T,?>> |
Base class for Attitude Data Message parsers.
|
AdmParser.RotationOrderConsumer |
Interface representing instance methods that consume otation order values.
|
Aem |
This class stores all the information of the Attitude Ephemeris Message (AEM) File parsed
by AEMParser.
|
AemData |
The Attitude Ephemerides data blocks class contain list of attitude data points.
|
AemMetadata |
This class gathers the meta-data present in the Attitude Data Message (ADM).
|
AemMetadataKey |
|
AemParser |
A parser for the CCSDS AEM (Attitude Ephemeris Message).
|
AemSatelliteEphemeris |
AEM ephemeris blocks for a single satellite.
|
AemSegment |
This class stores the metadata and data for one attitude segment.
|
AemWriter |
A writer for Attitude Ephemeris Messsage (AEM) files.
|
AggregateBoundedAttitudeProvider |
A BoundedAttitudeProvider that covers a larger time span from several constituent
attitude providers that cover shorter time spans.
|
AggregateBoundedPropagator |
A BoundedPropagator that covers a larger time span from several constituent
propagators that cover shorter time spans.
|
AggregatedPVCoordinatesProvider |
Aggreate multiple PVCoordinatesProvider instances together
This can be used to describe an aircraft or surface vehicle.
|
AggregatedPVCoordinatesProvider.Builder |
|
AggregatedPVCoordinatesProvider.InvalidPVProvider |
|
AGILeapSecondFilesLoader |
Loader for UTC-TAI extracted from LeapSecond file from AGI.
|
AGILeapSecondFilesLoader.Parser |
Internal class performing the parsing.
|
AlignmentDetector |
Finder for satellite/body alignment events in orbital plane.
|
AlongTrackAiming |
Class used to orient tiles along an orbit track.
|
AltCovarianceType |
Flag indicating the type of alternate covariance information provided.
|
AltitudeDetector |
Finder for satellite altitude crossing events.
|
AmbiguityAcceptance |
Interface defining ambiguity acceptance tests.
|
AmbiguitySolver |
Class for solving integer ambiguity problems.
|
AngleType |
Antenna geometry represented in the angle date.
|
AngularAzEl |
Class modeling an Azimuth-Elevation measurement from a ground station.
|
AngularAzElBuilder |
|
AngularCoordinates |
Simple container for rotation/rotation rate/rotation acceleration triplets.
|
AngularDerivativesFilter |
|
AngularIonosphericDelayModifier |
Class modifying theoretical angular measurement with ionospheric delay.
|
AngularRaDec |
Class modeling an Right Ascension - Declination measurement from a ground point (station, telescope).
|
AngularRaDecBuilder |
|
AngularRadioRefractionModifier |
Class modifying theoretical angular measurement with ionospheric radio refractive index.
|
AngularSeparationDetector |
Detects when spacecraft comes close to a moving beacon, as seen from a moving observer.
|
AngularSeparationFromSatelliteDetector |
Detects when two moving objects come close to each other, as seen from spacecraft.
|
AngularTroposphericDelayModifier |
Class modifying theoretical angular measurement with tropospheric delay.
|
Antenna |
GNSS antenna model.
|
AntexLoader |
Factory for GNSS antennas (both receiver and satellite).
|
Apm |
This class stores all the information of the Attitude Parameter Message (APM) File parsed
by APMParser.
|
ApmData |
Container for Attitude Parameter Message data.
|
ApmParser |
A parser for the CCSDS APM (Attitude Parameter Message).
|
ApmQuaternion |
Container for Attitude Parameter Message quaternion logical block.
|
ApmQuaternionKey |
|
ApmWriter |
Writer for CCSDS Orbit Parameter Message.
|
AppliedDCBS |
Corrections of Differential Code Biases (DCBs) applied.
|
AppliedPCVS |
Corrections of antenna phase center variations (PCVs) applied.
|
ApsideDetector |
Finder for apside crossing events.
|
AstronomicalAmplitudeReader |
Parser for tides astronomical amplitude Hf.
|
Atmosphere |
Interface for atmospheric models.
|
AtmosphericRefractionModel |
Defines an refraction model that can be used to correct
for the apparent position of an object due to atmospheric effects.
|
Attitude |
This class handles attitude definition at a given date.
|
AttitudeBuilder |
This interface represents a builder for attitude.
|
AttitudeEndoints |
Endpoints for attitude definition.
|
AttitudeEntryKey |
Keys for attitude entries in XML messages.
|
AttitudeEphemerisFile<C extends TimeStampedAngularCoordinates,S extends AttitudeEphemerisFile.AttitudeEphemerisSegment<C>> |
An interface for accessing the data stored in an attitude ephemeris file.
|
AttitudeEphemerisFile.AttitudeEphemerisSegment<C extends TimeStampedAngularCoordinates> |
A segment of an attitude ephemeris for a satellite.
|
AttitudeEphemerisFile.SatelliteAttitudeEphemeris<C extends TimeStampedAngularCoordinates,S extends AttitudeEphemerisFile.AttitudeEphemerisSegment<C>> |
|
AttitudeEphemerisFileParser<T extends AttitudeEphemerisFile<?,?>> |
Parse an ephemeris file.
|
AttitudeEphemerisFileWriter |
An interface for writing out ephemeris files to disk.
|
AttitudeProvider |
This interface represents an attitude provider model set.
|
AttitudeProviderModifier |
This interface represents an attitude provider that modifies/wraps another underlying provider.
|
AttitudesSequence |
This classes manages a sequence of different attitude providers that are activated
in turn according to switching events.
|
AttitudesSequence.SwitchHandler |
Interface for attitude switch notifications.
|
AttitudeType |
Enumerate for ADM attitude type.
|
AttitudeWriter |
|
Authentication |
|
AuxiliaryElements |
Container class for common parameters used by all DSST forces.
|
BaseRangeIonosphericDelayModifier |
Base class modifying theoretical range measurement with ionospheric delay.
|
BaseRangeRateIonosphericDelayModifier |
Base class modifying theoretical range-rate measurement with ionospheric delay.
|
BaseRangeRateTroposphericDelayModifier |
Baselass modifying theoretical range-rate measurements with tropospheric delay.
|
BaseRangeTroposphericDelayModifier |
Base class modifying theoretical range measurements with tropospheric delay.
|
BasicConstantThrustPropulsionModel |
Constant thrust propulsion model with:
- Constant thrust direction in spacecraft frame
- Parameter drivers (for estimation) for the thrust norm or the flow rate.
|
BatchLSEstimator |
Least squares estimator for orbit determination.
|
BatchLSModel |
|
BatchLSObserver |
|
BDTScale |
Beidou system time scale.
|
BeidouAlmanac |
Class for BeiDou almanac.
|
BeidouGeo |
Attitude providers for Beidou geostationary orbit navigation satellites.
|
BeidouIGSO |
Attitude providers for Beidou inclined geosynchronous orbit navigation satellites.
|
BeidouMeo |
Attitude providers for Beidou Medium Earth Orbit navigation satellites.
|
BeidouNavigationMessage |
Container for data contained in a BeiDou navigation message.
|
Bias<T extends ObservedMeasurement<T>> |
Class modeling a measurement bias.
|
BistaticRange |
Class modeling a bistatic range measurement using
an emitter ground station and a receiver ground station.
|
BistaticRangeBuilder |
|
BistaticRangeIonosphericDelayModifier |
Class modifying theoretical bistatic range measurement with ionospheric delay.
|
BistaticRangeRate |
Class modeling a bistatic range rate measurement using
an emitter ground station and a receiver ground station.
|
BistaticRangeRateBuilder |
|
BistaticRangeRateIonosphericDelayModifier |
Class modifying theoretical bistatic range-rate measurement with ionospheric delay.
|
BistaticRangeRateTroposphericDelayModifier |
Class modifying theoretical bistatic range-rate measurements with tropospheric delay.
|
BistaticRangeTroposphericDelayModifier |
Class modifying theoretical bistatic range measurement with tropospheric delay.
|
BodiesElements |
Elements of the bodies having an effect on nutation.
|
BodyCenterPointing |
This class handles body center pointing attitude provider.
|
BodyFacade |
Facade in front of several center bodies in CCSDS messages.
|
BodyShape |
Interface representing the rigid surface shape of a natural body.
|
BooleanDetector |
This class provides AND and OR operations for event detectors.
|
BoundedAttitudeProvider |
This interface is intended for attitude ephemerides valid only during a time range.
|
BoundedPropagator |
This interface is intended for ephemerides valid only during a time range.
|
BoxAndSolarArraySpacecraft |
Class representing the features of a classical satellite
with a convex body shape and rotating flat solar arrays.
|
BoxAndSolarArraySpacecraft.Facet |
Class representing a single facet of a convex spacecraft body.
|
BrouwerLyddanePropagator |
This class propagates a SpacecraftState
using the analytical Brouwer-Lyddane model (from J2 to J5 zonal harmonics).
|
BrouwerLyddanePropagatorBuilder |
Builder for Brouwer-Lyddane propagator.
|
BurstSelector |
Selector generating high rate bursts of dates separated by some rest period.
|
ByteArrayEncodedMessages |
Encoded messages as a byte array.
|
CachedNormalizedSphericalHarmonicsProvider |
|
CarrierPhase |
|
CartesianCovariance |
Container for OPM/OMM/OCM Cartesian covariance matrix.
|
CartesianCovarianceKey |
|
CartesianCovarianceWriter |
Writer for covariance matrix data.
|
CartesianDerivativesFilter |
|
CartesianOrbit |
This class holds Cartesian orbital parameters.
|
CasterRecord |
Caster record in source table.
|
Cdm |
This class stores all the information of the Conjunction Data Message (CDM) File parsed
by CdmParser.
|
CdmData |
Container for Conjunction Data Message data.
|
CdmHeader |
Header of a CCSDS Conjunction Data Message.
|
CdmHeaderKey |
|
CdmHeaderProcessingState |
|
CdmMessageWriter |
Cdm message writer.
|
CdmMetadata |
This class gathers the meta-data present in the Conjunction Data Message (CDM).
|
CdmMetadataKey |
|
CdmMetadataWriter |
Writer for Metadata for CCSDS Conjunction Data Messages.
|
CdmParser |
Base class for Conjunction Data Message parsers.
|
CdmRelativeMetadata |
This class gathers the relative meta-data present in the Conjunction Data Message (CDM).
|
CdmRelativeMetadataKey |
|
CdmSegment |
This class stores the metadata and data for one object.
|
CdmWriter |
Writer for CCSDS Conjunction Data Message.
|
CelestialBodies |
Commonly used celestial bodies.
|
CelestialBody |
Interface for celestial bodies like Sun, Moon or solar system planets.
|
CelestialBodyFactory |
Factory class for bodies of the solar system.
|
CelestialBodyFrame |
Frames used in CCSDS Orbit Data Messages.
|
CelestialBodyLoader |
Interface for loading celestial bodies.
|
CelestialBodyPointed |
This class handles a celestial body pointed attitude provider.
|
CenterName |
Orbit central bodies for which a Celestial body can be created.
|
ChronologicalComparator |
|
CircularFieldOfView |
Class representing a spacecraft sensor Field Of View with circular shape.
|
CircularOrbit |
This class handles circular orbital parameters.
|
CjSjCoefficient |
Compute the Sj(k, h) and the Cj(k, h) series
and their partial derivatives with respect to k and h.
|
ClassicalRungeKuttaIntegratorBuilder |
Builder for ClassicalRungeKuttaIntegrator.
|
ClasspathCrawler |
Provider for data files stored as resources in the classpath.
|
ClockCorrection |
Container for SSR clock correction data.
|
ClockCorrectionsProvider |
Provider for clock corrections as additional states.
|
CodeBias |
Container for code bias data.
|
CoefficientsFactory |
This class is designed to provide coefficient from the DSST theory.
|
CoefficientsFactory.NSKey |
Key formed by two integer values.
|
CombinationType |
Enumerate for combination of measurements types.
|
CombinedDerivatives |
Container for additional derivatives.
|
CombinedObservationData |
Combined observation data.
|
CombinedObservationDataSet |
Combined observation data set.
|
CommentsContainer |
Container for comments in various CCSDS messages.
|
CommonGnssData |
Container for common GNSS data contained in almanac and navigation messages.
|
CommonMetadata |
Common metadata for Orbit Parameter/Ephemeris/Mean Messages.
|
CommonMetadataKey |
|
CommonMetadataWriter |
Writer for Common metadata for CCSDS Orbit Parameter/Ephemeris/Mean Messages.
|
CommonPhysicalProperties |
|
ComparableMeasurement |
Base interface for comparing measurements regardless of their type.
|
CompositeDataContext |
A simple implementation of DataContext that composes the constituent factories
into a data context.
|
ConfigurableLowThrustManeuver |
This class implements a configurable low thrust maneuver.
|
ConstantAzimuthAiming |
Class used to orient tiles with respect to a geographic azimuth.
|
ConstantProcessNoise |
Provider for constant process noise matrices.
|
ConstantPVCoordinatesProvider |
Provider based on a single point.
|
Constants |
Set of useful physical constants.
|
ConstantThrustDirectionProvider |
Simple implementation of VariableThrustDirectionVector, providing a constant
direction.
|
ConstantThrustManeuver |
This class implements a simple maneuver with constant thrust.
|
ContextBinding |
Context for parsing/writing Navigation Data Message.
|
ContinueOnEvent<T extends EventDetector> |
Event handler which will always return continue as a state.
|
ContinuousScheduler<T extends ObservedMeasurement<T>> |
Scheduler generating measurements sequences continuously.
|
CorrectionApplied |
Indicator for corrections application.
|
Covariance |
Covariance entry.
|
CovarianceHistory |
Covariance history.
|
CovarianceHistoryMetadata |
Metadata for covariance history.
|
CovarianceHistoryMetadataKey |
|
CovarianceMatrixProvider |
Provider for process noise matrices.
|
CovarianceMethod |
Maneuvrable possibilities used in CCSDS Conjunction Data Messages.
|
CPF |
This class stores all the information of the Consolidated laser ranging Prediction File (CPF) parsed
by CPFParser.
|
CPF.CPFCoordinate |
A single record of position and possibility velocity in an SP3 file.
|
CPFHeader |
Container for Consolidated laser ranging Prediction File (CPF) header.
|
CPFParser |
A parser for the CPF orbit file format.
|
CPFWriter |
An CPF Writer class that can take in a general EphemerisFile object
and export it as a valid CPF file.
|
CR3BPConstants |
Set of useful physical CR3BP constants using JPL data.
|
CR3BPDifferentialCorrection |
Class implementing the differential correction method for Halo or Lyapunov
Orbits.
|
CR3BPFactory |
Factory class creating predefined CR3BP system using CR3BPSystem class.
|
CR3BPForceModel |
Class calculating the acceleration induced by CR3BP model.
|
CR3BPMultipleShooter |
Multiple shooting method applicable for orbits, either propagation in CR3BP, or in an ephemeris model.
|
CR3BPRotatingFrame |
Class creating the rotating frame centered on the barycenter of the CR3BP System.
|
CR3BPSystem |
Class creating, from two different celestial bodies, the corresponding system
with respect to the Circular Restricted Three Body problem hypotheses.
|
CRD |
This class stores all the information of the Consolidated laser ranging Data Format (CRD) parsed
by CRDParser.
|
CRD.AnglesMeasurement |
Pointing angles record.
|
CRD.CRDDataBlock |
Data block containing a set of data contain in the CRD file.
|
CRD.Meteo |
Meteorological data.
|
CRD.MeteorologicalMeasurement |
This data record contains a minimal set of meteorological data.
|
CRD.RangeMeasurement |
Range record.
|
CRDConfiguration |
Container for Consolidated laser ranging Data Format (CDR) configuration records.
|
CRDConfiguration.DetectorConfiguration |
Container for detector configuration record.
|
CRDConfiguration.LaserConfiguration |
Container for laser configuration record.
|
CRDConfiguration.MeteorologicalConfiguration |
Container for meteorological configuration record.
|
CRDConfiguration.SoftwareConfiguration |
Container for software configuration record.
|
CRDConfiguration.SystemConfiguration |
Container for system configuration record.
|
CRDConfiguration.TimingSystemConfiguration |
Container for timing system configuration record.
|
CRDConfiguration.TransponderConfiguration |
Container for transponder configuration record.
|
CRDHeader |
Container for Consolidated laser ranging Data Format (CDR) header.
|
CRDHeader.RangeType |
Range type for SLR data.
|
CRDParser |
A parser for the CRD data file format.
|
CssiSpaceWeatherData |
This class provides three-hourly and daily solar activity data needed by atmospheric
models: F107 solar flux, Ap and Kp indexes.
|
CssiSpaceWeatherDataLoader |
This class reads solar activity data from CSSI Space Weather files for the
class CssiSpaceWeatherData .
|
CssiSpaceWeatherDataLoader.LineParameters |
Container class for Solar activity indexes.
|
CssiSpaceWeatherDataLoader.LineReader |
Deprecated.
|
CycleSlipDetectorResults |
This class is used to contains all the data computed within cycle-slip detector.
|
CycleSlipDetectors |
Interface for phase measurement cycle-slip detection.
|
Data |
This marker interface represents segment data.
|
DataContext |
Provides auxiliary data for portions of the application.
|
DataField |
Interface for data fields used to parsed encoded messages.
|
DataFilter |
|
DataFormat |
|
DataLoader |
|
DataProvider |
|
DataProvidersManager |
|
DataQuality |
Quality of the data.
|
DataSource |
Container associating a name with a stream or reader that can be opened lazily.
|
DataSource.Opener |
Interface for lazy-opening data streams one time.
|
DataSource.ReaderOpener |
Interface for lazy-opening a characters stream one time.
|
DataSource.StreamOpener |
Interface for lazy-opening a binary stream one time.
|
DataStreamRecord |
Data stream record in source table.
|
DateBasedManeuverTriggers |
Maneuver triggers based on a start and end date.
|
DateComponents |
Class representing a date broken up as year, month and day components.
|
DateDetector |
Finder for date events.
|
DateDriver |
|
DatesSelector |
Interface for selecting dates within an interval.
|
DateTimeComponents |
Holder for date and time components.
|
DeepSDP4 |
This class contains the methods that compute deep space perturbation terms.
|
DefaultDataContext |
Indicates that the annotated method, field, or constructor uses the default data
context.
|
DefaultDataContextPlugin |
|
DelaunayArguments |
Delaunay arguments used for nutation or tides.
|
DeSitterRelativity |
De Sitter post-Newtonian correction force due to general relativity.
|
Differentiation |
Utility class for differentiating various kinds of functions.
|
DirectoryCrawler |
Provider for data files stored in a directories tree on filesystem.
|
DiscreteTroposphericModel |
Defines a tropospheric model, used to calculate the path delay imposed to
electro-magnetic signals between an orbital satellite and a ground station.
|
DivertedSingularityAiming |
Class used to orient tiles such that there are no singularities within the zone of interest.
|
DOP |
This class is a container for the result of a single DOP computation.
|
DOPComputer |
This class aims at computing the dilution of precision.
|
DormandPrince54IntegratorBuilder |
Builder for DormandPrince54Integrator.
|
DormandPrince853IntegratorBuilder |
Builder for DormandPrince853Integrator.
|
DoubleArrayDictionary |
String → double[] mapping, for small number of keys.
|
DoubleArrayDictionary.Entry |
Entry in a dictionary.
|
DoubleDihedraFieldOfView |
Class representing a spacecraft sensor Field Of View with dihedral shape (i.e.
|
DragForce |
Atmospheric drag force model.
|
DragSensitive |
Interface for spacecraft that are sensitive to atmospheric drag forces.
|
DSSTAtmosphericDrag |
|
DSSTBatchLSModel |
|
DSSTForceModel |
This interface represents a force modifying spacecraft motion for a DSSTPropagator .
|
DSSTHarvester |
|
DSSTJacobiansMapper |
|
DSSTKalmanModel |
Deprecated.
|
DSSTNewtonianAttraction |
|
DSSTNewtonianAttractionContext |
|
DSSTPartialDerivativesEquations |
Deprecated.
|
DSSTPropagator |
This class propagates orbits using the DSST theory.
|
DSSTPropagatorBuilder |
Builder for DSST propagator.
|
DSSTSolarRadiationPressure |
|
DSSTTesseral |
Tesseral contribution to the central body gravitational perturbation.
|
DSSTTesseralContext |
This class is a container for the common parameters used in DSSTTesseral .
|
DSSTThirdBody |
|
DSSTThirdBodyContext |
Deprecated. |
DSSTThirdBodyDynamicContext |
This class is a container for the common parameters used in
DSSTThirdBody .
|
DSSTThirdBodyStaticContext |
This class is a container for the common parameters used in
DSSTThirdBody .
|
DSSTZonal |
Zonal contribution to the central body gravitational perturbation.
|
DSSTZonalContext |
This class is a container for the common parameters used in DSSTZonal .
|
DtcDataLoader |
|
DtcDataLoader.LineParameters |
Container class for Solar activity indexes.
|
DTM2000 |
This atmosphere model is the realization of the DTM-2000 model.
|
DTM2000InputParameters |
Container for solar activity data, compatible with DTM2000 Atmosphere model.
|
DualFrequencyHatchFilter |
Hatch Filter using Carrier-Phase measurements taken at two different frequencies,
to form a Divergence-Free phase combination.
|
DualFrequencySmoother |
Handler to perform pseudo-range smoothing using Divergence-Free phase combinations.
|
Duration |
Generator for one column of a Jacobian matrix for special case of maneuver duration.
|
DutyCycleType |
|
DynamicOutlierFilter<T extends ObservedMeasurement<T>> |
Modifier that sets estimated measurement weight to 0 if residual is too far from expected domain.
|
EarthITU453AtmosphereRefraction |
Implementation of refraction model for Earth exponential atmosphere based on ITU-R P.834-7 recommendation.
|
EarthShape |
All models of Earth's shape have some common properties that are not shared with
arbitrary BodyShape s.
|
EarthStandardAtmosphereRefraction |
Implementation of refraction model for Earth standard atmosphere.
|
EcksteinHechlerPropagator |
This class propagates a SpacecraftState
using the analytical Eckstein-Hechler model.
|
EcksteinHechlerPropagatorBuilder |
Builder for Eckstein-Hechler propagator.
|
EclipseDetector |
Finder for satellite eclipse related events.
|
EclipticProvider |
An inertial frame aligned with the ecliptic.
|
ECOM2 |
The Empirical CODE Orbit Model 2 (ECOM2) of the Center for Orbit Determination in Europe (CODE).
|
EGMFormatReader |
This reader is adapted to the EGM Format.
|
ElementsType |
|
ElevationDetector |
Finder for satellite raising/setting events that allows for the
setting of azimuth and/or elevation bounds or a ground azimuth/elevation
mask input.
|
ElevationExtremumDetector |
Detector for elevation extremum with respect to a ground point.
|
ElevationFilter<T extends ObservedMeasurement<T>> |
Elevation pre-processing filter.
|
ElevationMask |
Class for modeling the ground elevation values around a given point.
|
Ellipse |
Model of a 2D ellipse in 3D space.
|
Ellipsoid |
Modeling of a general three-axes ellipsoid.
|
EllipsoidTessellator |
Class used to tessellate an interest zone on an ellipsoid in either
tiles or grids of geodetic points .
|
EllipticalFieldOfView |
Class representing a spacecraft sensor Field Of View with elliptical shape.
|
EnablingPredicate<S extends EventDetector> |
This interface represents an event enabling predicate function.
|
EncodedMessage |
Interface for getting bits forming encoded messages.
|
EOPBasedTransformProvider |
|
EOPEntry |
This class holds an Earth Orientation Parameters entry.
|
EOPHistory |
This class loads any kind of Earth Orientation Parameter data throughout a large time range.
|
EOPHistoryLoader |
Interface for loading Earth Orientation Parameters history.
|
EOPHistoryLoader.Parser |
Interface for parsing EOP data files.
|
Ephemeris |
This class is designed to accept and handle tabulated orbital entries.
|
EphemerisFile<C extends TimeStampedPVCoordinates,S extends EphemerisFile.EphemerisSegment<C>> |
An interface for accessing the data stored in an ephemeris file and using the data to
create a working Propagator .
|
EphemerisFile.EphemerisSegment<C extends TimeStampedPVCoordinates> |
A segment of an ephemeris for a satellite.
|
EphemerisFile.SatelliteEphemeris<C extends TimeStampedPVCoordinates,S extends EphemerisFile.EphemerisSegment<C>> |
Contains the information about a single satellite from an EphemerisFile .
|
EphemerisFileParser<T extends EphemerisFile<?,?>> |
Parse an ephemeris file.
|
EphemerisFileWriter |
An interface for writing out ephemeris files to disk.
|
EphemerisGenerator |
Generator for ephemerides.
|
EphemerisPropagatorBuilder |
Builder for Ephemeris propagator.
|
EphemerisWriter |
|
EpochDerivativesEquations |
|
EquinoctialOrbit |
This class handles equinoctial orbital parameters, which can support both
circular and equatorial orbits.
|
ErrorState |
|
EskfMeasurementHandler |
Deprecated. |
EstimatedEarthFrameProvider |
Class modeling an Earth frame whose Earth Orientation Parameters can be estimated.
|
EstimatedIonosphericModel |
An estimated ionospheric model.
|
EstimatedMeasurement<T extends ObservedMeasurement<T>> |
|
EstimatedMeasurement.Status |
Enumerate for the status of the measurement.
|
EstimatedTroposphericModel |
An estimated tropospheric model.
|
EstimationModifier<T extends ObservedMeasurement<T>> |
Interface for estimated measurements modifiers used for orbit determination.
|
EstimationsProvider |
Interface for retrieving estimated measurements during orbit determination.
|
Euler |
|
EulerIntegratorBuilder |
Builder for EulerIntegrator.
|
EulerKey |
|
EventBasedManeuverTriggers |
Maneuver triggers based on start and stop detectors.
|
EventBasedScheduler<T extends ObservedMeasurement<T>> |
|
EventDetector |
This interface represents space-dynamics aware events detectors.
|
EventEnablingPredicateFilter<T extends EventDetector> |
Wrapper used to detect events only when enabled by an external predicated function.
|
EventHandler<T extends EventDetector> |
An interface defining how to override event handling behavior in the standard
propagator eventing classes without requiring subclassing.
|
EventMultipleHandler<D extends EventDetector> |
Facade handlers that allows to use several handlers for one detector.
|
EventShifter<T extends EventDetector> |
Wrapper shifting events occurrences times.
|
EventsLogger |
This class logs events detectors events during propagation.
|
EventsLogger.LoggedEvent |
Class for logged events entries.
|
EventSlopeFilter<T extends EventDetector> |
Wrapper used to detect only increasing or decreasing events.
|
EventState<T extends EventDetector> |
This class handles the state for one event detector during integration steps.
|
EventState.EventOccurrence |
Class to hold the data related to an event occurrence that is needed to decide how
to modify integration.
|
ExceptionalDataContext |
A data context that always throws a runtime exception when it's methods are used.
|
ExtendedPVCoordinatesProvider |
Interface for PV coordinates providers that also support fields.
|
ExtremumApproachDetector |
Finder for extremum approach events.
|
FactoryManagedFrame |
Base class for the predefined frames that are managed by Frames .
|
FESCHatEpsilonReader |
Reader for ocean tides files following the fes2004.dat format.
|
FESCnmSnmReader |
Reader for ocean tides files following the fes2004_Cnm-Snm.dat format.
|
FieldAbsoluteDate<T extends CalculusFieldElement<T>> |
This class represents a specific instant in time.
|
FieldAbsolutePVCoordinates<T extends CalculusFieldElement<T>> |
Field implementation of AbsolutePVCoordinates.
|
FieldAbstractAnalyticalPropagator<T extends CalculusFieldElement<T>> |
|
FieldAbstractDetector<D extends FieldEventDetector<T>,T extends CalculusFieldElement<T>> |
Common parts shared by several orbital events finders.
|
FieldAbstractGaussianContributionContext<T extends CalculusFieldElement<T>> |
|
FieldAbstractIntegratedPropagator<T extends CalculusFieldElement<T>> |
Common handling of FieldPropagator
methods for both numerical and semi-analytical propagators.
|
FieldAbstractIntegratedPropagator.MainStateEquations<T extends CalculusFieldElement<T>> |
Differential equations for the main state (orbit, attitude and mass).
|
FieldAbstractPropagator<T extends CalculusFieldElement<T>> |
Common handling of Propagator methods for analytical propagators.
|
FieldAdditionalDerivativesProvider<T extends CalculusFieldElement<T>> |
Provider for additional derivatives.
|
FieldAdditionalEquations<T extends CalculusFieldElement<T>> |
Deprecated.
|
FieldAdditionalEquationsAdapter<T extends CalculusFieldElement<T>> |
Deprecated.
|
FieldAdditionalStateProvider<T extends CalculusFieldElement<T>> |
This interface represents providers for additional state data beyond SpacecraftState .
|
FieldAltitudeDetector<T extends CalculusFieldElement<T>> |
Finder for satellite altitude crossing events.
|
FieldAngularCoordinates<T extends CalculusFieldElement<T>> |
|
FieldApsideDetector<T extends CalculusFieldElement<T>> |
Finder for apside crossing events.
|
FieldArrayDictionary<T extends CalculusFieldElement<T>> |
String → CalculusFieldElement[] mapping, for small number of keys.
|
FieldAttitude<T extends CalculusFieldElement<T>> |
This class handles attitude definition at a given date.
|
FieldAuxiliaryElements<T extends CalculusFieldElement<T>> |
Container class for common parameters used by all DSST forces.
|
FieldBodiesElements<T extends CalculusFieldElement<T>> |
Elements of the bodies having an effect on nutation.
|
FieldBoundedPropagator<T extends CalculusFieldElement<T>> |
This interface is intended for ephemerides valid only during a time range.
|
FieldBrouwerLyddanePropagator<T extends CalculusFieldElement<T>> |
This class propagates a FieldSpacecraftState
using the analytical Brouwer-Lyddane model (from J2 to J5 zonal harmonics).
|
FieldCartesianOrbit<T extends CalculusFieldElement<T>> |
This class holds Cartesian orbital parameters.
|
FieldCircularOrbit<T extends CalculusFieldElement<T>> |
This class handles circular orbital parameters.
|
FieldCjSjCoefficient<T extends CalculusFieldElement<T>> |
Compute the Sj(k, h) and the Cj(k, h) series
and their partial derivatives with respect to k and h.
|
FieldCombinedDerivatives<T extends CalculusFieldElement<T>> |
Container for additional derivatives.
|
FieldContinueOnEvent<KK extends FieldEventDetector<T>,T extends CalculusFieldElement<T>> |
Event handler which will always return continue as a state.
|
FieldDateDetector<T extends CalculusFieldElement<T>> |
Finder for date events.
|
FieldDeepSDP4<T extends CalculusFieldElement<T>> |
This class contains the methods that compute deep space perturbation terms.
|
FieldDelaunayArguments<T extends CalculusFieldElement<T>> |
Delaunay arguments used for nutation or tides.
|
FieldDSSTNewtonianAttractionContext<T extends CalculusFieldElement<T>> |
|
FieldDSSTPropagator<T extends CalculusFieldElement<T>> |
This class propagates orbits using the DSST theory.
|
FieldDSSTTesseralContext<T extends CalculusFieldElement<T>> |
This class is a container for the common "field" parameters used in DSSTTesseral .
|
FieldDSSTThirdBodyContext<T extends CalculusFieldElement<T>> |
This class is a container for the common "field" parameters used in DSSTThirdBody .
|
FieldDSSTThirdBodyDynamicContext<T extends CalculusFieldElement<T>> |
This class is a container for the common "field" parameters used in DSSTThirdBody .
|
FieldDSSTZonalContext<T extends CalculusFieldElement<T>> |
This class is a container for the common "field" parameters used in DSSTZonal .
|
FieldEcksteinHechlerPropagator<T extends CalculusFieldElement<T>> |
|
FieldEclipseDetector<T extends CalculusFieldElement<T>> |
Finder for satellite eclipse related events.
|
FieldElevationDetector<T extends CalculusFieldElement<T>> |
Finder for satellite raising/setting events that allows for the
setting of azimuth and/or elevation bounds or a ground azimuth/elevation
mask input.
|
FieldEphemerisGenerator<T extends CalculusFieldElement<T>> |
Generator for ephemerides.
|
FieldEquinoctialOrbit<T extends CalculusFieldElement<T>> |
This class handles equinoctial orbital parameters, which can support both
circular and equatorial orbits.
|
FieldEventDetector<T extends CalculusFieldElement<T>> |
This interface represents space-dynamics aware events detectors.
|
FieldEventHandler<KK extends FieldEventDetector<T>,T extends CalculusFieldElement<T>> |
An interface defining how to override event handling behavior in the standard
propagator eventing classes without requiring subclassing.
|
FieldEventsLogger<T extends CalculusFieldElement<T>> |
This class logs events detectors events during propagation.
|
FieldEventsLogger.FieldLoggedEvent<T extends CalculusFieldElement<T>> |
Class for logged events entries.
|
FieldEventState<D extends FieldEventDetector<T>,T extends CalculusFieldElement<T>> |
This class handles the state for one event detector during integration steps.
|
FieldEventState.EventOccurrence<T extends CalculusFieldElement<T>> |
Class to hold the data related to an event occurrence that is needed to decide how
to modify integration.
|
FieldFixedNumberInterpolationGrid<T extends CalculusFieldElement<T>> |
Interpolation grid where a fixed number of points are
evenly spaced between the start and the end of the integration step.
|
FieldForceModelContext<T extends CalculusFieldElement<T>> |
Base class for dsst force models parameter containers.
|
FieldFunctionalDetector<T extends CalculusFieldElement<T>> |
|
FieldGammaMnsFunction<T extends CalculusFieldElement<T>> |
Compute the Γmn,s(γ) function from equation 2.7.1-(13).
|
FieldGeodeticPoint<T extends CalculusFieldElement<T>> |
|
FieldGHIJjsPolynomials<T extends CalculusFieldElement<T>> |
Compute the Gjs, Hjs, Ijs and Jjs
polynomials in the equinoctial elements h, k and the direction cosines α and β
and their partial derivatives with respect to k, h, α and β.
|
FieldGHmsjPolynomials<T extends CalculusFieldElement<T>> |
Compute the Gmsj and the Hmsj
polynomials in the equinoctial elements h, k and the direction cosines α and β
and their partial derivatives with respect to k, h, α and β.
|
FieldHansenTesseralLinear<T extends CalculusFieldElement<T>> |
Hansen coefficients K(t,n,s) for t!=0 and n < 0.
|
FieldHansenThirdBodyLinear<T extends CalculusFieldElement<T>> |
Hansen coefficients K(t,n,s) for t=0 and n > 0.
|
FieldHansenZonalLinear<T extends CalculusFieldElement<T>> |
Hansen coefficients K(t,n,s) for t=0 and n < 0.
|
FieldIntegratedEphemeris<T extends CalculusFieldElement<T>> |
This class stores sequentially generated orbital parameters for
later retrieval.
|
FieldInterpolationGrid<T extends CalculusFieldElement<T>> |
Interface for interpolation grids.
|
FieldKeplerianAnomalyUtility |
Utility methods for converting between different Keplerian anomalies.
|
FieldKeplerianOrbit<T extends CalculusFieldElement<T>> |
This class handles traditional Keplerian orbital parameters.
|
FieldKeplerianPropagator<T extends CalculusFieldElement<T>> |
Simple Keplerian orbit propagator.
|
FieldLatitudeCrossingDetector<T extends CalculusFieldElement<T>> |
Detector for geographic latitude crossing.
|
FieldLegendrePolynomials<T extends CalculusFieldElement<T>> |
Computes the Pnm(t) coefficients.
|
FieldLnsCoefficients<T extends CalculusFieldElement<T>> |
Compute the Lns(γ).
|
FieldManeuverTriggersResetter<T extends CalculusFieldElement<T>> |
Resetter for maneuver triggers.
|
FieldMaxGapInterpolationGrid<T extends CalculusFieldElement<T>> |
Interpolation grid where points obey a maximum time gap.
|
FieldNodeDetector<T extends CalculusFieldElement<T>> |
Finder for node crossing events.
|
FieldNumericalPropagator<T extends CalculusFieldElement<T>> |
This class propagates orbits using
numerical integration.
|
FieldOfView |
Interface representing a spacecraft sensor Field Of View.
|
FieldOfViewDetector |
Finder for target entry/exit events with respect to a satellite sensor
Field Of View .
|
FieldOrbit<T extends CalculusFieldElement<T>> |
This class handles orbital parameters.
|
FieldOrekitFixedStepHandler<T extends CalculusFieldElement<T>> |
This interface is a space-dynamics aware fixed size step handler.
|
FieldOrekitStepHandler<T extends CalculusFieldElement<T>> |
This interface is a space-dynamics aware step handler.
|
FieldOrekitStepInterpolator<T extends CalculusFieldElement<T>> |
This interface is a space-dynamics aware step interpolator.
|
FieldOrekitStepNormalizer<T extends CalculusFieldElement<T>> |
|
FieldParameterDrivenDateIntervalDetector<T extends CalculusFieldElement<T>> |
Detector for date intervals that may be offset thanks to parameter drivers.
|
FieldPoleCorrection<T extends CalculusFieldElement<T>> |
Simple container class for pole correction parameters.
|
FieldPropagator<T extends CalculusFieldElement<T>> |
This interface provides a way to propagate an orbit at any time.
|
FieldPVCoordinates<T extends CalculusFieldElement<T>> |
|
FieldPVCoordinatesProvider<T extends CalculusFieldElement<T>> |
Interface for PV coordinates providers.
|
FieldRecordAndContinue<T extends FieldEventDetector<E>,E extends CalculusFieldElement<E>> |
Handler that will record every time an event occurs and always return Action.CONTINUE .
|
FieldRecordAndContinue.Event<T,F extends CalculusFieldElement<F>> |
A single event detected during propagation.
|
FieldSGP4<T extends CalculusFieldElement<T>> |
This class contains methods to compute propagated coordinates with the SGP4 model.
|
FieldShortPeriodicsInterpolatedCoefficient<T extends CalculusFieldElement<T>> |
Interpolated short periodics coefficients.
|
FieldShortPeriodTerms<T extends CalculusFieldElement<T>> |
Additive short period terms contributing to the mean to osculating orbit mapping.
|
FieldSpacecraftState<T extends CalculusFieldElement<T>> |
This class is the representation of a complete state holding orbit, attitude
and mass information at a given date.
|
FieldStateMapper<T extends CalculusFieldElement<T>> |
|
FieldStepHandlerMultiplexer<T extends CalculusFieldElement<T>> |
|
FieldStopOnDecreasing<KK extends FieldEventDetector<T>,T extends CalculusFieldElement<T>> |
Handle a detection event and choose what to do next.
|
FieldStopOnEvent<KK extends FieldEventDetector<T>,T extends CalculusFieldElement<T>> |
Event handler which will always return continue as a state.
|
FieldStopOnIncreasing<KK extends FieldEventDetector<T>,T extends CalculusFieldElement<T>> |
Handle a detection event and choose what to do next.
|
FieldTimeDerivativesEquations<T extends CalculusFieldElement<T>> |
Interface summing up the contribution of several forces into orbit and mass derivatives.
|
FieldTimeInterpolable<T extends FieldTimeInterpolable<T,KK>,KK extends CalculusFieldElement<KK>> |
This interface represents objects that can be interpolated in time.
|
FieldTimeShiftable<T extends FieldTimeInterpolable<T,KK>,KK extends CalculusFieldElement<KK>> |
This interface represents objects that can be shifted in time.
|
FieldTimeSpanMap<T,D extends CalculusFieldElement<D>> |
Container for objects that apply to spans of time.
|
FieldTimeSpanMap.Transition<S,D extends CalculusFieldElement<D>> |
Local class holding transition times.
|
FieldTimeStamped<T extends CalculusFieldElement<T>> |
This interface represents objects that have a AbsoluteDate
date attached to them.
|
FieldTLE<T extends CalculusFieldElement<T>> |
This class is a container for a single set of TLE data.
|
FieldTLEPropagator<T extends CalculusFieldElement<T>> |
This class provides elements to propagate TLE's.
|
FieldTransform<T extends CalculusFieldElement<T>> |
Transformation class in three dimensional space.
|
FieldTransformGenerator<T extends CalculusFieldElement<T>> |
|
FileFormat |
Enumerate for file format.
|
FilesListCrawler |
Provider for data files in an explicit list.
|
FiltersManager |
|
FilterType |
|
FiniteDifferencePropagatorConverter |
Propagator converter using finite differences to compute the Jacobian.
|
FixedFrameBuilder |
Builder that assumes angular coordinates are given in a fixed frame.
|
FixedNumberInterpolationGrid |
Interpolation grid where a fixed number of points are
evenly spaced between the start and the end of the integration step.
|
FixedRate |
This class handles a simple attitude provider at constant rate around a fixed axis.
|
FixedStepSelector |
Selector generating a continuous stream of dates separated by a constant step.
|
FixedTransformProvider |
Transform provider using fixed transform.
|
FixedTroposphericDelay |
A static tropospheric model that interpolates the actual tropospheric delay
based on values read from a configuration file (tropospheric-delay.txt) via
the DataProvidersManager .
|
FootprintOverlapDetector |
Detector triggered by geographical region entering/leaving a spacecraft sensor
Field Of View .
|
ForceModel |
This interface represents a force modifying spacecraft motion.
|
ForceModelContext |
Base class for dsst force models attributes containers.
|
Frame |
Tridimensional references frames class.
|
FrameAncestorException |
|
FrameFacade |
Facade in front of several frames types in CCSDS messages.
|
Frames |
A collection of commonly used Frame s.
|
FramesFactory |
Factory for predefined reference frames.
|
Frequency |
Enumerate for GNSS frequencies.
|
FrequencyPattern |
Pattern for GNSS antenna model on one frequency.
|
FunctionalDetector |
|
FundamentalNutationArguments |
Class computing the fundamental arguments for nutation and tides.
|
Galileo |
Attitude providers for Galileo navigation satellites.
|
GalileoAlmanac |
Class for Galileo almanac.
|
GalileoNavigationMessage |
Container for data contained in a Galileo navigation message.
|
GalileoScale |
Galileo system time scale.
|
GammaMnsFunction |
Compute the Γmn,s(γ) function from equation 2.7.1-(13).
|
Generator |
|
Generator |
Generation interface for CCSDS messages.
|
GenericGNSS |
Attitude providers for navigation satellites for which no specialized model is known.
|
GenericTimeStampedCache<T extends TimeStamped> |
|
GeodeticPoint |
Point location relative to a 2D body surface.
|
GeographicZoneDetector |
Detector for entry/exit of a zone defined by geographic boundaries.
|
Geoid |
A geoid is a level surface of the gravity potential of a body.
|
GeoMagneticElements |
Contains the elements to represent a magnetic field at a single point.
|
GeoMagneticField |
Used to calculate the geomagnetic field at a given geodetic point on earth.
|
GeoMagneticFieldFactory |
|
GeoMagneticFieldFactory.FieldModel |
The currently supported geomagnetic field models.
|
GeoMagneticFields |
Methods for obtaining geomagnetic fields.
|
GeoMagneticModelLoader |
Loads geomagnetic field models from a given input stream.
|
GeometryFreeCombination |
Geometry-free combination.
|
GeometryFreeCycleSlipDetector |
Geometry free cycle slip detectors.
|
GHIJjsPolynomials |
Compute the Gjs, Hjs, Ijs and Jjs
polynomials in the equinoctial elements h, k and the direction cosines α and β
and their partial derivatives with respect to k, h, α and β.
|
GHmsjPolynomials |
Compute the Gmsj and the Hmsj
polynomials in the equinoctial elements h, k and the direction cosines α and β
and their partial derivatives with respect to k, h, α and β.
|
GillIntegratorBuilder |
Builder for GillIntegrator.
|
GlobalIonosphereMapModel |
Global Ionosphere Map (GIM) model.
|
GlobalMappingFunctionModel |
The Global Mapping Function model for radio techniques.
|
GlobalPressureTemperature2Model |
The Global Pressure and Temperature 2 (GPT2) model.
|
GlobalPressureTemperatureModel |
The Global Pressure and Temperature model.
|
Glonass |
Attitude providers for Glonass navigation satellites.
|
GLONASSAlmanac |
This class holds a GLONASS almanac as read from .agl files.
|
GLONASSAnalyticalPropagator |
|
GLONASSAnalyticalPropagatorBuilder |
This nested class aims at building a GLONASSAnalyticalPropagator.
|
GLONASSDate |
Container for date in GLONASS form.
|
GLONASSEphemeris |
|
GLONASSNavigationMessage |
Container for data contained in a Glonass navigation message.
|
GLONASSNumericalPropagator |
This class propagates GLONASS orbits using numerical integration.
|
GLONASSNumericalPropagatorBuilder |
This nested class aims at building a GLONASSNumericalPropagator.
|
GLONASSOrbitalElements |
|
GLONASSScale |
GLONASS time scale.
|
GlonassUserRangeAccuracy |
Enumerate for GLONASS User Range Accuracy.
|
GMSTScale |
Greenwich Mean Sidereal Time.
|
GNSSAttitudeProvider |
Attitude providers for navigation satellites.
|
GNSSClockElements |
|
GNSSConstants |
Set of useful physical constants used in Global Navigation Satellite Systems (GNSS).
|
GnssData |
GNSS data retrieved from Ntrip caster.
|
GNSSDate |
Container for date in GNSS form.
|
GNSSOrbitalElements |
This interface provides the minimal set of orbital elements needed by the GNSSPropagator .
|
GNSSPropagator |
|
GNSSPropagatorBuilder |
This nested class aims at building a GNSSPropagator.
|
GPSAlmanac |
This class holds a GPS almanac as read from SEM or YUMA files.
|
GPSBlockIIA |
Attitude providers for GPS block IIA navigation satellites.
|
GPSBlockIIF |
Attitude providers for GPS block IIF navigation satellites.
|
GPSBlockIIR |
Attitude providers for GPS block IIR navigation satellites.
|
GPSNavigationMessage |
Container for data contained in a GPS navigation message.
|
GPSScale |
GPS time scale.
|
GraggBulirschStoerIntegratorBuilder |
Builder for GraggBulirschStoerIntegrator.
|
GRAPHICCombination |
GRoup And Phase Ionospheric Calibration (GRAPHIC) combination.
|
GravityFieldFactory |
Factory used to read gravity field files in several supported formats.
|
GravityFields |
Defines methods for obtaining gravity fields.
|
GRGSFormatReader |
Reader for the GRGS gravity field format.
|
GroundAtNightDetector |
Detector for ground location being at night.
|
GroundFieldOfViewDetector |
Finder for satellite entry/exit events with respect to a sensor Field Of View attached to an arbitrary frame.
|
GroundPointing |
Base class for ground pointing attitude providers.
|
GroundStation |
Class modeling a ground station that can perform some measurements.
|
GTODProvider |
Greenwich True Of Date Frame, also known as True of Date Rotating frame (TDR)
or Greenwich Rotating Coordinate frame (GCR).
|
GzipFilter |
Filter for gzip compressed data.
|
HaloOrbit |
Class calculating different parameters of a Halo Orbit.
|
HaloXZPlaneCrossingDetector |
Detector for XZ Plane crossing.
|
HansenTesseralLinear |
Hansen coefficients K(t,n,s) for t!=0 and n < 0.
|
HansenThirdBodyLinear |
Hansen coefficients K(t,n,s) for t=0 and n > 0.
|
HansenUtilities |
Utilities class.
|
HansenZonalLinear |
Hansen coefficients K(t,n,s) for t=0 and n < 0.
|
HarmonicAccelerationModel |
Harmonic acceleration model.
|
HarrisPriester |
This atmosphere model is the realization of the Modified Harris-Priester model.
|
HatanakaCompressFilter |
Decompression filter for Hatanaka compressed RINEX files.
|
Header |
Header of a CCSDS Navigation Data Message.
|
HeaderKey |
|
HeaderProcessingState |
|
HelmertTransformation |
Transformation class for geodetic systems.
|
HelmertTransformation.Predefined |
Enumerate for predefined Helmert transformations.
|
HighamHall54IntegratorBuilder |
Builder for HighamHall54Integrator.
|
HolmesFeatherstoneAttractionModel |
This class represents the gravitational field of a celestial body.
|
IAUPole |
Interface for IAU pole and prime meridian orientations.
|
ICGEMFormatReader |
Reader for the ICGEM gravity field format.
|
IdentityConverter |
Identity converter for Range Units.
|
IERSConventions |
Supported IERS conventions.
|
IERSConventions.NutationCorrectionConverter |
Interface for functions converting nutation corrections between
δΔψ/δΔε to δX/δY.
|
IgsSsrDataField |
Enum containing all intermediate level data fields that can be parsed
to build an IGS SSR message.
|
IgsSsrMessagesParser |
Parser for SSR encoded messages.
|
IgsSsrMessageType |
Enum containing the supported IGS SSR messages types.
|
ILRSHeader |
Container for common data contains in International Laser Ranging Service (ILRS) files header.
|
ImmutableTimeStampedCache<T extends TimeStamped> |
A cache of TimeStamped data that provides concurrency through
immutability.
|
ImpulseManeuver<T extends EventDetector> |
Impulse maneuver model.
|
InertialForces |
Inertial force model.
|
InertialProvider |
This class handles an attitude provider aligned with a frame or a fixed offset to it.
|
InputStreamEncodedMessages |
Encoded message from an input stream.
|
IntegerBootstrapping |
Bootstrapping engine for ILS problem solving.
|
IntegerLeastSquareComparator |
|
IntegerLeastSquareSolution |
Class holding a solution to an Integer Least Square problem.
|
IntegerLeastSquareSolver |
Interface for algorithms solving integer least square problems.
|
IntegratedEphemeris |
This class stores sequentially generated orbital parameters for
later retrieval.
|
IntegrationReference |
Relationship between time tag and integration interval.
|
InterpolatingTransformProvider |
Transform provider using thread-safe interpolation on transforms sample.
|
InterpolationGrid |
Interface for interpolation grids.
|
InterpolationMethod |
OEM interpolation method.
|
InterpolationTableLoader |
Used to read an interpolation table from a data file.
|
InterSatDirectViewDetector |
Detector for inter-satellites direct view (i.e.
|
InterSatellitesPhase |
Phase measurement between two satellites.
|
InterSatellitesPhaseAmbiguityModifier |
Class modifying theoretical inter-satellites phase measurement with ambiguity.
|
InterSatellitesPhaseBuilder |
|
InterSatellitesRange |
One-way or two-way range measurements between two satellites.
|
InterSatellitesRangeBuilder |
|
IntervalEventTrigger<T extends AbstractDetector<T>> |
Maneuver triggers based on a single event detector that defines firing intervals.
|
IodGibbs |
Gibbs initial orbit determination.
|
IodGooding |
Gooding angles only initial orbit determination, assuming Keplerian motion.
|
IodLambert |
Lambert initial orbit determination, assuming Keplerian motion.
|
IodLaplace |
Laplace angles-only initial orbit determination, assuming Keplerian motion.
|
IonosphereFreeCombination |
Ionosphere-free combination.
|
IonosphericGradientConverter |
Deprecated.
|
IonosphericMappingFunction |
Interface for mapping functions used in the ionospheric delay computation.
|
IonosphericModel |
Defines a ionospheric model, used to calculate the path delay imposed to
electro-magnetic signals between an orbital satellite and a ground station.
|
IRNSSAlmanac |
Class for IRNSS almanac.
|
IRNSSNavigationMessage |
Container for data contained in an IRNSS navigation message.
|
IRNSSScale |
IRNSS time scale (also called IRNWT for IRNSS NetWork Time).
|
IsotropicDrag |
This class models isotropic drag effects.
|
IsotropicRadiationClassicalConvention |
This class represents the features of a simplified spacecraft.
|
IsotropicRadiationCNES95Convention |
This class represents the features of a simplified spacecraft.
|
IsotropicRadiationSingleCoefficient |
This class represents the features of a simplified spacecraft.
|
ITRFVersion |
Enumerate for ITRF versions.
|
ITRFVersion.Converter |
Specialized transform provider between ITRF frames.
|
ITRFVersionLoader |
Loader for ITRF version configuration file.
|
ITRFVersionLoader.ITRFVersionConfiguration |
ITRF version configuration entry.
|
ItrfVersionProvider |
Interface for retrieving the ITRF version for a given set of EOP data.
|
J2DifferentialEffect |
Analytical model for J2 effect.
|
JacobianPropagatorConverter |
Propagator converter using the real Jacobian.
|
JacobiansMapper |
|
JacobiPolynomials |
Provider of the Jacobi polynomials Plv,w.
|
JB2008 |
This is the realization of the Jacchia-Bowman 2008 atmospheric model.
|
JB2008InputParameters |
Interface for solar activity and magnetic activity data.
|
JB2008SpaceEnvironmentData |
This class provides a container for the solar indices data required by the JB2008
atmospheric model.
|
JPLEphemeridesLoader |
Loader for JPL ephemerides binary files (DE 4xx) and similar formats (INPOP 06/08/10).
|
JPLEphemeridesLoader.EphemerisType |
List of supported ephemerides types.
|
JPLEphemeridesLoader.RawPVProvider |
Interface for raw position-velocity retrieval.
|
KalmanEstimation |
|
KalmanEstimator |
Implementation of a Kalman filter to perform orbit determination.
|
KalmanEstimatorBuilder |
Builder for a Kalman filter estimator.
|
KalmanEstimatorUtil |
Utility class for Kalman Filter.
|
KalmanModel |
|
KalmanObserver |
|
KeplerianAnomalyUtility |
Utility methods for converting between different Keplerian anomalies.
|
KeplerianElements |
Container for Keplerian elements.
|
KeplerianElementsKey |
|
KeplerianOrbit |
This class handles traditional Keplerian orbital parameters.
|
KeplerianPropagator |
Simple Keplerian orbit propagator.
|
KeplerianPropagatorBuilder |
Builder for Keplerian propagator.
|
KlobucharIonoCoefficientsLoader |
Loads Klobuchar-Style ionospheric coefficients a given input stream.
|
KlobucharIonoModel |
Klobuchar ionospheric delay model.
|
KnockeRediffusedForceModel |
The Knocke Earth Albedo and IR emission force model.
|
KvnGenerator |
Generator for Key-Value Notation CCSDS messages.
|
KvnLexicalAnalyzer |
Lexical analyzer for Key-Value Notation CCSDS messages.
|
KvnStructureKey |
|
KvnStructureProcessingState |
|
L1Frame |
|
L1TransformProvider |
L1 Transform provider for a frame on the L1 Lagrange point of two celestial bodies.
|
L2Frame |
Class to create a L2 centered frame with L2TransformProvider .
|
LagrangianPoints |
Enumerate for selecting which Lagrangian Point to consider in different classes.
|
LambdaMethod |
Decorrelation/reduction engine for LAMBDA method.
|
LatitudeCrossingDetector |
Detector for geographic latitude crossing.
|
LatitudeExtremumDetector |
Detector for geographic latitude extremum.
|
LazyLoadedCelestialBodies |
This class lazily loads auxiliary data when it is needed by a requested body.
|
LazyLoadedDataContext |
A data context that aims to match the behavior of Orekit 10.0 regarding auxiliary data.
|
LazyLoadedEop |
Loads Earth Orientation Parameters (EOP) from a configured set of EOPHistoryLoader s on demand.
|
LazyLoadedFrames |
This class lazily loads auxiliary data when it is needed by a requested frame.
|
LazyLoadedGeoMagneticFields |
Loads magnetic fields on request and can be configured after creation.
|
LazyLoadedGravityFields |
Loads gravity fields when first requested and can be configured until then.
|
LazyLoadedTimeScales |
An implementation of TimeScales that loads auxiliary data, leap seconds and
UT1-UTC, when it is first accessed.
|
LegendrePolynomials |
Computes the Pnm(t) coefficients.
|
LenseThirringRelativity |
Lense-Thirring post-Newtonian correction force due to general relativity.
|
LexicalAnalyzer |
Interface for CCSDS messages lexical analysis.
|
LexicalAnalyzerSelector |
|
LibrationOrbit |
Base class for libration orbits.
|
LibrationOrbitFamily |
|
LibrationOrbitType |
|
LnsCoefficients |
Compute the Lns(γ).
|
LocalizedException |
This interface specified methods implemented by localized exception classes.
|
LocalOrbitalFrame |
Class for frames moving with an orbiting satellite.
|
LofOffset |
Attitude law defined by fixed Roll, Pitch and Yaw angles (in any order)
with respect to a local orbital frame.
|
LofOffsetPointing |
This class provides a default attitude provider.
|
LOFType |
Enumerate for different types of Local Orbital Frames.
|
LongitudeCrossingDetector |
Detector for geographic longitude crossing.
|
LongitudeExtremumDetector |
Detector for geographic longitude extremum.
|
LoveNumbers |
Container for Love numbers.
|
Loxodrome |
Perform calculations on a loxodrome (commonly, a rhumb line) on an ellipsoid.
|
LoxodromeArc |
Loxodrome defined by a start and ending point.
|
LutherIntegratorBuilder |
Builder for LutherIntegrator.
|
LyapunovOrbit |
Class calculating different parameters of a Lyapunov Orbit.
|
MagneticFieldDetector |
Detector for South-Atlantic anomaly frontier crossing.
|
ManBasis |
|
Maneuver |
Maneuver in an APM file.
|
Maneuver |
Maneuver entry.
|
Maneuver |
Maneuver in an OPM file.
|
Maneuver |
A generic model for maneuvers.
|
ManeuverFieldType |
|
ManeuverHistory |
Maneuver history.
|
ManeuverHistoryMetadata |
Metadata for maneuver history.
|
ManeuverHistoryMetadataKey |
|
ManeuverKey |
|
ManeuverKey |
|
ManeuverTriggers |
Generic interface for the maneuver triggers used in a Maneuver .
|
ManeuverTriggersResetter |
Resetter for maneuver triggers.
|
Maneuvrable |
Maneuvrable possibilities used in CCSDS Conjunction Data Messages.
|
MappingFunction |
Interface for mapping functions used in the tropospheric delay computation.
|
MariniMurrayModel |
The Marini-Murray tropospheric delay model for laser ranging.
|
MarshallSolarActivityFutureEstimation |
This class reads and provides solar activity data needed by
atmospheric models: F107 solar flux, Ap and Kp indexes.
|
MarshallSolarActivityFutureEstimation.StrengthLevel |
Strength level of activity.
|
MassDepletionDelay |
Generator for effect of delaying mass depletion when delaying a maneuver.
|
MatricesHarvester |
Interface for extracting State Transition Matrices and Jacobians matrices from spacecraft state .
|
MaxGapInterpolationGrid |
Interpolation grid where points obey a maximum time gap.
|
MeasurementBuilder<T extends ObservedMeasurement<T>> |
|
MeasurementCombination |
Interface for combination of measurements.
|
MeasurementCombinationFactory |
Factory for predefined combination of measurements.
|
MeasurementDecorator |
|
MeasurementFilter<T extends ObservedMeasurement<T>> |
Interface for measurement pre-processing filter.
|
MeasurementType |
Enumerate for measurement type.
|
MedianDate |
Generator for one column of a Jacobian matrix for special case of maneuver median date.
|
MelbourneWubbenaCombination |
Melbourne-Wübbena combination.
|
MendesPavlisModel |
The Mendes - Pavlis tropospheric delay model for optical techniques.
|
MessageObserver |
Interface for objects that needs to be notified when new encoded messages are available.
|
MessageParser<T> |
Parser for CCSDS messages.
|
MessagesParser |
Parser for IGS encoded messages.
|
MessageType |
Interface for encoded message types.
|
MessageVersionXmlTokenBuilder |
Builder for the root element with CCSDS message version.
|
MessageWriter<H extends Header,S extends Segment<?,?>,F extends NdmConstituent<H,S>> |
Interface for writing Navigation Data Message (NDM) files.
|
Metadata |
This class gathers the meta-data present in the Navigation Data Message (ADM, ODM and TDM).
|
MetadataKey |
|
MidpointIntegratorBuilder |
Builder for MidpointIntegrator.
|
ModelObserver |
Observer for model calls.
|
ModifiedFrame |
A reference frame created from the REF_FRAME and CENTER_NAME is a CCSDS
OPM, OMM, or OEM file.
|
ModifiedLambdaMethod |
Decorrelation/reduction engine for Modified LAMBDA method.
|
ModifierGradientConverter |
Converter for states and parameters arrays.
|
Month |
Enumerate representing a calendar month.
|
MultipleShooter |
Multiple shooting method applicable for trajectories, in an ephemeris model.
|
MultipleShooting |
Interface for Multiple shooting methods.
|
MultiplexedMeasurement |
Class multiplexing several measurements as one.
|
MultiSatStepHandler |
|
NadirPointing |
This class handles nadir pointing attitude provider.
|
NarrowLaneCombination |
Narrow-Lane combination.
|
NavigationSystem |
|
Ndm |
CCSDS Navigation Data Message.
|
NdmConstituent<H extends Header,S extends Segment<?,?>> |
Constituents of a CCSDS Navigation Data Message.
|
NdmParser |
A parser for the CCSDS NDM (Navigation Data Message).
|
NdmWriter |
Writer for CCSDS Navigation Data Message.
|
NegateDetector |
An event detector that negates the sign on another event detector's g function.
|
NeQuickModel |
NeQuick ionospheric delay model.
|
NetworkCrawler |
Provider for data files directly fetched from network.
|
NetworkRecord |
Network record in source table.
|
NewcombOperators |
Implementation of the Modified Newcomb Operators.
|
NewtonianAttraction |
Force model for Newtonian central body attraction.
|
NiellMappingFunctionModel |
The Niell Mapping Function model for radio wavelengths.
|
NodeDetector |
Finder for node crossing events.
|
NormalizedSphericalHarmonicsProvider |
Interface used to provide normalized spherical harmonics coefficients.
|
NormalizedSphericalHarmonicsProvider.NormalizedSphericalHarmonics |
The normalized geopotential coefficients at a specific instance in time.
|
NRLMSISE00 |
This class implements the mathematical representation of the 2001
Naval Research Laboratory Mass Spectrometer and Incoherent Scatter
Radar Exosphere (NRLMSISE-00) of the MSIS® class model.
|
NRLMSISE00InputParameters |
Container for solar activity data, compatible with NRLMSISE-00 atmosphere model.
|
NtripClient |
Source table for ntrip streams retrieval.
|
NumericalPropagator |
This class propagates orbits using
numerical integration.
|
NumericalPropagatorBuilder |
Builder for numerical propagator.
|
ObjectType |
|
ObservableSatellite |
Class modeling a satellite that can be observed.
|
Observation |
The Observation class contains the data from an observation line.
|
ObservationData |
Observation Data.
|
ObservationDataSet |
Observation Data set.
|
ObservationsBlock |
The Observations Block class contain metadata and the list of observation data lines.
|
ObservationType |
|
ObservationType |
Enumerate for all the Observation Types for Rinex 2 and 3.
|
ObservedMeasurement<T extends ObservedMeasurement<T>> |
Interface for measurements used for orbit determination.
|
OceanLoadDeformationCoefficients |
Supported Ocean load Deformation coefficients (Love numbers k'i).
|
OceanLoading |
Modeling of displacement of reference points due to ocean loading.
|
OceanLoadingCoefficients |
Site specific coefficients for ocean loading.
|
OceanLoadingCoefficientsBLQFactory |
Factory for ocean loading coefficients, using Onsala Space Observatory files in BLQ format.
|
OceanTides |
Ocean tides force model.
|
OceanTidesReader |
Reader for ocean tides coefficients.
|
OceanTidesWave |
Container for ocen tides coefficients for one tide wave.
|
Ocm |
This class gathers the informations present in the Orbit Comprehensive Message (OCM).
|
OcmData |
Data container for Orbit Comprehensive Messages.
|
OcmDataSubStructureKey |
Keywords for OCM data sub-structure.
|
OcmMetadata |
|
OcmMetadataKey |
|
OcmParser |
A parser for the CCSDS OCM (Orbit Comprehensive Message).
|
OcmSatelliteEphemeris |
OCM ephemeris blocks for a single satellite.
|
OcmWriter |
Writer for CCSDS Orbit Comprehensive Message.
|
ODEIntegratorBuilder |
This interface is the top-level abstraction to build first order integrators for propagators conversion.
|
OdMethodFacade |
Facade in front of several orbit determination methods in CCSDS messages.
|
OdMethodType |
|
OdmMetadata |
This class gathers the meta-data present in the Orbital Data Message (ODM).
|
OdmMetadataKey |
|
OdmParser<T extends NdmConstituent<?,?>,P extends OdmParser<T,?>> |
Common parser for Orbit Parameter/Ephemeris/Mean/Comprehensive Messages.
|
ODParameters |
Container for OD parameters data block.
|
ODParametersKey |
|
ODParametersWriter |
Writer for OD parameters data block for CCSDS Conjunction Data Messages.
|
Oem |
This class stores all the information of the OEM File parsed by OEMParser.
|
OemData |
The Ephemerides data blocks class contain list of orbital data points.
|
OemMetadata |
Metadata for Orbit Ephemeris Messages.
|
OemMetadataKey |
|
OemParser |
A parser for the CCSDS OEM (Orbit Ephemeris Message).
|
OemSatelliteEphemeris |
OEM ephemeris blocks for a single satellite.
|
OemSegment |
The Ephemerides Blocks class contain metadata, the list of ephemerides data
lines and optional covariance matrices (and their metadata).
|
OemWriter |
A writer for Orbit Ephemeris Message (OEM) files.
|
OffsetModel |
TAI UTC offset model.
|
Omm |
This class gathers the informations present in the Orbital Mean-Elements Message (OMM).
|
OmmData |
Container for Orbit Mean-elements Message data.
|
OmmMetadata |
|
OmmMetadataKey |
|
OmmParser |
A parser for the CCSDS OMM (Orbiter Mean-Elements Message).
|
OmmTle |
Container for TLE data.
|
OmmTleKey |
|
OmmWriter |
Writer for CCSDS Orbit Mean Mean-Elements Message.
|
OnBoardAntennaInterSatellitesPhaseModifier |
On-board antenna offset effect on inter-satellites phase measurements.
|
OnBoardAntennaInterSatellitesRangeModifier |
On-board antenna offset effect on inter-satellites range measurements.
|
OnBoardAntennaOneWayGNSSPhaseModifier |
On-board antenna offset effect on one-way GNSS phase measurements.
|
OnBoardAntennaOneWayGNSSRangeModifier |
On-board antenna offset effect on one-way GNSS range measurements.
|
OnBoardAntennaPhaseModifier |
On-board antenna offset effect on phase measurements.
|
OnBoardAntennaRangeModifier |
On-board antenna offset effect on range measurements.
|
OnBoardAntennaTurnAroundRangeModifier |
On-board antenna offset effect on turn around range measurements.
|
OneAxisEllipsoid |
Modeling of a one-axis ellipsoid.
|
OneWayGNSSPhase |
One-way GNSS phase measurement.
|
OneWayGNSSPhaseAmbiguityModifier |
Class modifying theoretical one-way GNSS phase measurement with ambiguity.
|
OneWayGNSSRange |
One-way GNSS range measurement.
|
OnOff |
On/Off status for various elements.
|
Opm |
This class gathers the informations present in the Orbital Parameter Message (OPM).
|
OpmData |
Container for Orbit Parameter Message data.
|
OpmParser |
A parser for the CCSDS OPM (Orbit Parameter Message).
|
OpmWriter |
Writer for CCSDS Orbit Parameter Message.
|
OpsStatus |
|
Orbit |
This class handles orbital parameters.
|
OrbitCategory |
|
OrbitCorrection |
Container for SSR orbit correction data.
|
OrbitDetermination |
Orbit determination data.
|
OrbitDeterminationKey |
|
OrbitDeterminationPropagatorBuilder |
Base class for orbit determination model builders.
|
OrbitRelativeFrame |
Frames used in CCSDS Orbit Data Messages.
|
OrbitType |
Enumerate for orbital parameters types.
|
Ordering |
|
OrekitAttitudeEphemerisFile |
A class for encapsulating Orekit propagators within an AttitudeEphemerisFile
complaint object that makes for easy serialization to external ephemeris
formats like AEM.
|
OrekitAttitudeEphemerisFile.OrekitAttitudeEphemerisSegment |
|
OrekitAttitudeEphemerisFile.OrekitSatelliteAttitudeEphemeris |
|
OrekitConfiguration |
Utility class for setting global configuration parameters.
|
OrekitEphemerisFile |
A class for encapsulating Orekit propagators within an EphemerisFile
complaint object that makes for easy serialization to external ephemeris
formats like OEM.
|
OrekitEphemerisFile.OrekitEphemerisSegment |
|
OrekitEphemerisFile.OrekitSatelliteEphemeris |
|
OrekitException |
This class is the base class for all specific exceptions thrown by
the Orekit classes.
|
OrekitFixedStepHandler |
This interface is a space-dynamics aware fixed size step handler.
|
OrekitIllegalArgumentException |
|
OrekitIllegalStateException |
|
OrekitInternalError |
Extension of Runtime with localized message for internal errors only.
|
OrekitIOException |
|
OrekitMessages |
Enumeration for localized messages formats.
|
OrekitMessages.UTF8Control |
Control class loading properties in UTF-8 encoding.
|
OrekitParseException |
|
OrekitStepHandler |
This interface is a space-dynamics aware step handler.
|
OrekitStepInterpolator |
This interface is a space-dynamics aware step interpolator.
|
OrekitStepNormalizer |
|
OrphanFrame |
Prototype frame that can be built from leaf to roots and later attached to a tree.
|
OsculatingToMeanElementsConverter |
This class converts osculating orbital elements into mean elements.
|
OutlierFilter<T extends ObservedMeasurement<T>> |
Modifier that sets estimated measurement weight to 0 if residual is too far from expected domain.
|
ParameterDrivenDateIntervalDetector |
Detector for date intervals that may be offset thanks to parameter drivers.
|
ParameterDriver |
Class allowing to drive the value of a parameter.
|
ParameterDriversList |
|
ParameterDriversList.DelegatingDriver |
Specialized driver delegating to several other managing
the same parameter name.
|
ParameterFunction |
|
ParameterObserver |
Interface for observing parameters changes.
|
ParametersDriversProvider |
|
ParametricAcceleration |
This class implements a parametric acceleration.
|
ParsedMessage |
Abstract base class for decoded IGS messages.
|
ParsedUnitsBehavior |
Behavior adopted for units that have been parsed from a CCSDS message.
|
Parser |
Parser for units.
|
ParserBuilder |
|
ParseToken |
Token occurring during CCSDS file parsing.
|
ParseToken.BooleanConsumer |
Interface representing instance methods that consume boolean values.
|
ParseToken.CenterConsumer |
Interface representing instance methods that consume center values.
|
ParseToken.CenterListConsumer |
Interface representing instance methods that consume center lists.
|
ParseToken.CharConsumer |
Interface representing instance methods that consume character values.
|
ParseToken.DateConsumer |
Interface representing instance methods that consume date values.
|
ParseToken.DoubleArrayConsumer |
Interface representing instance methods that consume double array.
|
ParseToken.DoubleConsumer |
Interface representing instance methods that consume double values.
|
ParseToken.DoublyIndexedDoubleConsumer |
Interface representing instance methods that consume doubly-indexed double values.
|
ParseToken.EnumConsumer<T extends Enum<T>> |
Interface representing instance methods that consume enum values.
|
ParseToken.EnumListConsumer<T extends Enum<T>> |
Interface representing instance methods that consume lists of enum values.
|
ParseToken.FrameConsumer |
Interface representing instance methods that consume frame values.
|
ParseToken.IndexedDoubleConsumer |
Interface representing instance methods that consume indexed double values.
|
ParseToken.IndexedStringConsumer |
Interface representing instance methods that consume indexed string values.
|
ParseToken.IntConsumer |
Interface representing instance methods that consume integer values.
|
ParseToken.IntegerArrayConsumer |
Interface representing instance methods that consume integer array.
|
ParseToken.LabeledDoubleConsumer |
Interface representing instance methods that consume labeled double values.
|
ParseToken.ManeuvrableConsumer |
Interface representing instance methods that consume Maneuvrable values.
|
ParseToken.StringConsumer |
Interface representing instance methods that consume string values.
|
ParseToken.StringListConsumer |
Interface representing instance methods that consume lists of strings values.
|
ParseToken.TimeSystemConsumer |
Interface representing instance methods that consume time systems values.
|
ParseToken.UnitListConsumer |
Interface representing instance methods that consume units lists values.
|
ParseToken.VectorConsumer |
Interface representing instance methods that consume vector values.
|
PartialDerivativesEquations |
Deprecated.
|
Perturbations |
Perturbation parameters.
|
PerturbationsKey |
|
Phase |
Class modeling a phase measurement from a ground station.
|
PhaseAmbiguityModifier |
Class modifying theoretical phase measurement with ambiguity.
|
PhaseBias |
Container for phase bias data.
|
PhaseBuilder |
Builder for Phase measurements.
|
PhaseCenterVariationFunction |
Model for antennas phase center variations.
|
PhaseIonosphericDelayModifier |
Class modifying theoretical phase measurement with ionospheric delay.
|
PhaseMinusCodeCombination |
Phase minus Code combination.
|
PhaseMinusCodeCycleSlipDetector |
Phase minus code cycle slip detectors.
|
PhaseTroposphericDelayModifier |
Class modifying theoretical phase measurement with tropospheric delay.
|
PhysicalProperties |
Spacecraft physical properties.
|
PhysicalPropertiesKey |
|
PocMethodFacade |
Facade in front of several probability of collision methods in CCSDS messages.
|
PocMethodType |
|
PoissonSeries |
Class representing a Poisson series for nutation or ephemeris computations.
|
PoissonSeries.CompiledSeries |
This interface represents a fast evaluator for Poisson series.
|
PoissonSeriesParser |
|
PoleCorrection |
Simple container class for pole correction parameters.
|
PolygonalFieldOfView |
Class representing a spacecraft sensor Field Of View with polygonal shape.
|
PolygonalFieldOfView.DefiningConeType |
Enumerate for cone/polygon relative position.
|
PolynomialAccelerationModel |
Polynomial acceleration model.
|
PolynomialFunctionMatrix |
|
PolynomialNutation |
Polynomial nutation function.
|
PolynomialParser |
Parser for polynomials in IERS tables.
|
PolynomialParser.Unit |
Unit for the coefficients.
|
Position |
Class modeling a position only measurement.
|
PositionAngle |
Enumerate for true, eccentric and mean position angles.
|
PositionAngleDetector |
Detector for in-orbit position angle.
|
PositionBuilder |
|
PotentialCoefficientsReader |
This abstract class represents a Gravitational Potential Coefficients file reader.
|
PowerTerm |
A container for a term with associated power.
|
Predefined |
Predefined frames provided by Frames .
|
ProcessingState |
Interface for processing parsing tokens for CCSDS NDM files.
|
PropagationType |
Enumerate to define the propagation type used by the propagator.
|
Propagator |
This interface provides a way to propagate an orbit at any time.
|
PropagatorBuilder |
This interface is the top-level abstraction to build propagators for conversion.
|
PropagatorConverter |
This interface is the top-level abstraction for propagators conversions.
|
PropagatorsParallelizer |
This class provides a way to propagate simultaneously several orbits.
|
PropulsionModel |
Generic interface for a propulsion model used in a Maneuver .
|
PV |
Class modeling a position-velocity measurement.
|
PVBuilder |
Builder for PV measurements.
|
PVCoordinates |
Simple container for Position/Velocity/Acceleration triplets.
|
PVCoordinatesProvider |
Interface for PV coordinates providers.
|
PyhonData |
|
PythonAbstractAnalyticalGradientConverter |
|
PythonAbstractAnalyticalMatricesHarvester |
|
PythonAbstractAnalyticalPropagator |
|
PythonAbstractBatchLSModel |
|
PythonAbstractBuilder<T extends AbstractBuilder<T>> |
|
PythonAbstractConstantThrustPropulsionModel |
|
PythonAbstractConstituentParser<T extends NdmConstituent<?,?>,P extends AbstractConstituentParser<T,?>> |
|
PythonAbstractCovarianceMatrixProvider |
|
PythonAbstractCycleSlipDetector |
|
PythonAbstractDetector<T extends AbstractDetector<T>> |
Common parts shared by several orbital events finders.
|
PythonAbstractDragForceModel |
|
PythonAbstractDualFrequencyCombination |
|
PythonAbstractEopParser |
|
PythonAbstractFieldOfView |
|
PythonAbstractForceModel |
|
PythonAbstractFrames |
|
PythonAbstractGaussianContribution |
|
PythonAbstractGenerator |
|
PythonAbstractGradientConverter |
|
PythonAbstractIntegratedPropagator |
|
PythonAbstractKalmanEstimator |
|
PythonAbstractKalmanModel |
|
PythonAbstractLambdaMethod |
|
PythonAbstractListCrawler<T> |
|
PythonAbstractManeuverTriggers |
|
PythonAbstractMatricesHarvester |
|
PythonAbstractMeasurement<T extends ObservedMeasurement<T>> |
|
PythonAbstractMeasurementBuilder<T extends ObservedMeasurement<T>> |
|
PythonAbstractMessageParser<T> |
|
PythonAbstractMessageWriter<H extends Header,S extends Segment<?,?>,F extends NdmConstituent<H,S>> |
|
PythonAbstractMultipleShooting |
|
PythonAbstractPropagator |
|
PythonAbstractPropagatorBuilder |
|
PythonAbstractPropagatorConverter |
|
PythonAbstractRadiationForceModel |
|
PythonAbstractScheduler<T extends ObservedMeasurement<T>> |
|
PythonAbstractSelfFeedingLoader |
|
PythonAbstractSingleFrequencyCombination |
|
PythonAbstractTimeScales |
|
PythonAbstractWriter |
|
PythonAccelerationModel |
|
PythonAccuracyProvider |
|
PythonAdditionalDerivativesProvider |
|
PythonAdditionalEquations |
This interface allows users to add their own differential equations to a numerical propagator.
|
PythonAdditionalStateProvider |
|
PythonAdmParser<T extends NdmConstituent<?,?>,P extends AbstractConstituentParser<T,?>> |
|
PythonAmbiguityAcceptance |
|
PythonAtmosphere |
|
PythonAtmosphericRefractionModel |
|
PythonAttitudeBuilder |
|
PythonAttitudeEphemerisFile |
|
PythonAttitudeEphemerisFileParser |
|
PythonAttitudeEphemerisFileWriter |
|
PythonAttitudeEphemerisSegment |
|
PythonAttitudeProvider |
|
PythonAttitudeProviderModifier |
|
PythonBatchLSObserver |
|
PythonBodyShape |
|
PythonBoundedAttitudeProvider |
|
PythonBoundedPropagator |
|
PythonCelestialBodies |
|
PythonCelestialBody |
|
PythonCelestialBodyLoader |
|
PythonComparableMeasurement |
|
PythonCovarianceMatrixProvider |
|
PythonCycleSlipDetectors |
|
PythonDataContext |
|
PythonDataFilter |
|
PythonDataLoader |
|
PythonDataProvider |
|
PythonDatesSelector |
|
PythonDiscreteTroposphericModel |
|
PythonDragSensitive |
|
PythonDSSTForceModel |
|
PythonDTM2000InputParameters |
|
PythonEarthShape |
|
PythonEnablingPredicate<S extends EventDetector> |
|
PythonEOPBasedTransformProvider |
|
PythonEOPHistoryLoader |
|
PythonEphemerisFile |
|
PythonEphemerisFileParser |
|
PythonEphemerisFileWriter |
|
PythonEphemerisGenerator |
|
PythonEstimationModifier<T extends ObservedMeasurement<T>> |
|
PythonEstimationsProvider |
|
PythonEventDetector |
This interface represents space-dynamics aware events detectors.
|
PythonEventHandler<T extends EventDetector> |
This interface represents space-dynamics aware events detectors.
|
PythonExtendedPVCoordinatesProvider |
|
PythonFieldAbstractAnalyticalPropagator<T extends CalculusFieldElement<T>> |
|
PythonFieldAbstractDetector<D extends FieldEventDetector<T>,T extends CalculusFieldElement<T>> |
|
PythonFieldAbstractIntegratedPropagator<T extends CalculusFieldElement<T>> |
|
PythonFieldAbstractPropagator<T extends CalculusFieldElement<T>> |
|
PythonFieldAdditionalDerivativesProvider<T extends CalculusFieldElement<T>> |
|
PythonFieldAdditionalEquations<T extends CalculusFieldElement<T>> |
This interface allows users to add their own differential equations to a numerical propagator.
|
PythonFieldAdditionalStateProvider<T extends CalculusFieldElement<T>> |
|
PythonFieldBoundedPropagator<T extends CalculusFieldElement<T>> |
|
PythonFieldEphemerisGenerator<T extends CalculusFieldElement<T>> |
|
PythonFieldEventDetector<T extends CalculusFieldElement<T>> |
|
PythonFieldEventHandler<KK extends FieldEventDetector<T>,T extends CalculusFieldElement<T>> |
|
PythonFieldManeuverTriggersResetter<T extends CalculusFieldElement<T>> |
|
PythonFieldOfView |
|
PythonFieldOrekitFixedStepHandler<T extends CalculusFieldElement<T>> |
|
PythonFieldOrekitStepHandler<T extends CalculusFieldElement<T>> |
|
PythonFieldOrekitStepInterpolator<T extends CalculusFieldElement<T>> |
|
PythonFieldPropagator<T extends CalculusFieldElement<T>> |
|
PythonFieldPVCoordinatesProvider<T extends CalculusFieldElement<T>> |
|
PythonFieldSDP4<T extends CalculusFieldElement<T>> |
|
PythonFieldShortPeriodTerms<T extends CalculusFieldElement<T>> |
|
PythonFieldStateMapper<T extends CalculusFieldElement<T>> |
|
PythonFieldTimeDerivativesEquations<T extends CalculusFieldElement<T>> |
|
PythonFieldTimeInterpolable<T extends FieldTimeInterpolable<T,KK>,KK extends CalculusFieldElement<KK>> |
|
PythonFieldTimeShiftable<T extends FieldTimeInterpolable<T,KK>,KK extends CalculusFieldElement<KK>> |
|
PythonFieldTimeStamped<T extends CalculusFieldElement<T>> |
|
PythonFieldUnivariateFunction |
|
PythonFieldUnivariateFunction |
|
PythonForceModel |
|
PythonGenerator |
|
PythonGeoMagneticFields |
|
PythonGNSSAttitudeProvider |
|
PythonGravityFields |
|
PythonGroundPointing |
|
PythonHatchFilter |
|
PythonIAUPole |
|
PythonILRSHeader |
|
PythonIntegerLeastSquareSolver |
|
PythonIntervalEventTrigger<T extends AbstractDetector<T>> |
|
PythonIonosphericMappingFunction |
|
PythonIonosphericModel |
|
PythonItrfVersionProvider |
|
PythonJB2008InputParameters |
|
PythonKalmanEstimation |
|
PythonKalmanObserver |
|
PythonLexicalAnalyzer |
|
PythonLibrationOrbit |
|
PythonLocalizedException |
|
PythonManeuverTriggers |
|
PythonManeuverTriggersResetter |
|
PythonMappingFunction |
|
PythonMatricesHarvester |
|
PythonMeasurementBuilder<T extends ObservedMeasurement<T>> |
|
PythonMeasurementCombination |
|
PythonMeasurementFilter<T extends ObservedMeasurement<T>> |
Interface for measurement pre-processing filter.
|
PythonMessageObserver |
|
PythonMessageParser<T> |
|
PythonMessageWriter<H extends Header,S extends Segment<?,?>,F extends NdmConstituent<H,S>> |
|
PythonModelObserver |
|
PythonMultipleShooting |
|
PythonMultiSatStepHandler |
|
PythonNdmConstituent<H extends Header,S extends Segment<?,?>> |
|
PythonNormalizedSphericalHarmonicsProvider |
|
PythonNRLMSISE00InputParameters |
|
PythonObservedMeasurement<T extends ObservedMeasurement<T>> |
|
PythonODEIntegratorBuilder |
|
PythonOdmParser<T extends NdmConstituent<?,?>,P extends OdmParser<T,?>> |
|
PythonOrbit |
|
PythonOrbitDeterminationPropagatorBuilder |
|
PythonOrekitFixedStepHandler |
This interface is a space-dynamics aware fixed size step handler.
|
PythonOrekitStepHandler |
|
PythonOrekitStepInterpolator |
|
PythonParameterFunction |
|
PythonParameterObserver |
|
PythonParametersDriversProvider |
|
PythonParametricModelEffect |
|
PythonParametricModelEffectGradient |
|
PythonParser |
|
PythonPartialsObserver |
|
PythonPhaseCenterVariationFunction |
|
PythonPotentialCoefficientsReader |
|
PythonPropagator |
|
PythonPropagatorBuilder |
|
PythonPropagatorConverter |
|
PythonPropulsionModel |
|
PythonPVCoordinatesProvider |
|
PythonRadiationSensitive |
|
PythonRangeUnitsConverter |
|
PythonRawSphericalHarmonicsProvider |
|
PythonReaderOpener |
|
PythonSatelliteAttitudeEphemeris |
|
PythonSBASOrbitalElements |
|
PythonScheduler<T extends ObservedMeasurement<T>> |
|
PythonSection |
|
PythonSemiAnalyticalProcess |
|
PythonSeriesTerm |
|
PythonShortPeriodTerms |
|
PythonSmoothFieldOfView |
|
PythonSphericalHarmonicsProvider |
|
PythonStartStopEventsTrigger<A extends AbstractDetector<A>,O extends AbstractDetector<O>> |
|
PythonStateFunction |
|
PythonStateJacobian |
|
PythonStateMapper |
|
PythonStaticTransform |
|
PythonStationDisplacement |
|
PythonStreamOpener |
|
PythonSupplier<T> |
A wrapper of the import java.util.function.Supplier Interface
|
PythonSwitchHandler |
|
PythonThrustDirectionProvider |
|
PythonThrustPropulsionModel |
|
PythonTideSystemProvider |
|
PythonTileAiming |
|
PythonTimeDerivativesEquations |
|
PythonTimeInterpolable<T extends TimeInterpolable<T>> |
|
PythonTimeScalarFunction |
|
PythonTimeScale |
|
PythonTimeScales |
|
PythonTimeShiftable<T extends TimeShiftable<T>> |
|
PythonTimeStamped |
|
PythonTimeStampedCache<T extends TimeStamped> |
|
PythonTimeStampedGenerator<T extends TimeStamped> |
|
PythonTimeVectorFunction |
|
PythonTLEPropagator |
|
PythonTransformProvider |
|
PythonUnivariateFunction |
import org.hipparchus.analysis.UnivariateFunction;
|
PythonUnivariateFunction |
import org.hipparchus.analysis.UnivariateFunction;
|
PythonUnnormalizedSphericalHarmonics |
|
PythonUnnormalizedSphericalHarmonicsProvider |
|
PythonUTCTAIOffsetsLoader |
|
PythonWeatherModel |
|
PythonXmlTokenBuilder |
|
QZSSAlmanac |
This class holds a QZSS almanac as read from YUMA files.
|
QZSSNavigationMessage |
Container for data contained in a QZSS navigation message.
|
QZSSScale |
QZSS time scale.
|
RadiationSensitive |
Interface for spacecraft that are sensitive to radiation pressure forces.
|
Range |
Class modeling a range measurement from a ground station.
|
RangeBuilder |
Builder for Range measurements.
|
RangeIonosphericDelayModifier |
Class modifying theoretical range measurement with ionospheric delay.
|
RangeMode |
Type of range tones.
|
RangeModifierUtil |
Utility class modifying theoretical range measurement.
|
RangeRate |
Class modeling one-way or two-way range rate measurement between two vehicles.
|
RangeRateBuilder |
|
RangeRateIonosphericDelayModifier |
Class modifying theoretical range-rate measurement with ionospheric delay.
|
RangeRateModifierUtil |
Utility class modifying theoretical range-rate measurement.
|
RangeRateTroposphericDelayModifier |
Class modifying theoretical range-rate measurements with tropospheric delay.
|
RangeTroposphericDelayModifier |
Class modifying theoretical range measurement with tropospheric delay.
|
RangeUnits |
Units of the range observable.
|
RangeUnitsConverter |
|
RawSphericalHarmonicsProvider |
Interface used to provide raw spherical harmonics coefficients.
|
RawSphericalHarmonicsProvider.RawSphericalHarmonics |
The raw spherical harmonics at a particular instant.
|
ReceiverAntenna |
GNSS receiver antenna model.
|
Record |
Record in source table.
|
RecordAndContinue<T extends EventDetector> |
Handler that will record every time an event occurs and always return Action.CONTINUE .
|
RecordAndContinue.Event<T> |
A single event detected during propagation.
|
RecordType |
Enumerate for record types in sourcetable.
|
ReferenceEllipsoid |
A Reference Ellipsoid for use in geodesy.
|
RegularXmlTokenBuilder |
Regular builder using XML elements names and content for tokens.
|
RelativisticClockInterSatellitesPhaseModifier |
Class modifying theoretical inter-satellites phase measurement with relativistic clock correction.
|
RelativisticClockInterSatellitesRangeModifier |
Class modifying theoretical inter-satellites range measurement with relativistic clock correction.
|
RelativisticClockOneWayGNSSPhaseModifier |
Class modifying theoretical one-way GNSS phase measurement with relativistic clock correction.
|
RelativisticClockOneWayGNSSRangeModifier |
Class modifying theoretical one-way GNSS range measurement with relativistic clock correction.
|
RelativisticClockPhaseModifier |
Class modifying theoretical phase measurement with relativistic clock correction.
|
RelativisticClockRangeModifier |
Class modifying theoretical range measurement with relativistic clock correction.
|
RelativisticClockRangeRateModifier |
Class modifying theoretical range-rate measurement with relativistic frequency deviation.
|
RelativisticJ2ClockInterSatellitesPhaseModifier |
Class modifying theoretical inter-satellites phase measurements with relativistic J2 clock correction.
|
RelativisticJ2ClockInterSatellitesRangeModifier |
Class modifying theoretical inter-satellites range measurements with relativistic J2 clock correction.
|
RelativisticJ2ClockOneWayGNSSPhaseModifier |
Class modifying theoretical one-way phase measurements with relativistic J2 clock correction.
|
RelativisticJ2ClockOneWayGNSSRangeModifier |
Class modifying one-way GNSS range theoretical measurements with relativistic J2 clock correction.
|
RelativisticJ2ClockPhaseModifier |
Class modifying theoretical phase measurements with relativistic J2 clock correction.
|
RelativisticJ2ClockRangeModifier |
Class modifying theoretical range measurements with relativistic J2 clock correction.
|
Relativity |
Post-Newtonian correction force due to general relativity.
|
ResidualFilter<T extends ObservedMeasurement<T>> |
Residual pre-processing filter.
|
RichardsonExpansion |
Class implementing the Third-Order Richardson Expansion.
|
RinexClock |
Represents a parsed clock file from the IGS.
|
RinexClock.ClockDataType |
Clock data type.
|
RinexClock.Receiver |
Represents a receiver or a satellite with its position in the considered frame.
|
RinexClock.ReferenceClock |
Represents a reference clock with its validity time span.
|
RinexClockParser |
A parser for the clock file from the IGS.
|
RinexNavigation |
Represents a parsed RINEX navigation messages files.
|
RinexNavigation.TimeSystemCorrection |
Container for time system corrections.
|
RinexNavigationParser |
Parser for RINEX navigation messages files.
|
RinexObservationHeader |
Container for Rinex observation file header.
|
RinexObservationLoader |
Loader for Rinex measurements files.
|
RotationXmlTokenBuilder |
Builder for rotation angles and rates.
|
Rtcm1019 |
RTCM 1019 message: GPS Satellite Ephemeris Data.
|
Rtcm1019Data |
Container for RTCM 1019 data.
|
Rtcm1020 |
RTCM 1020 message: Glonass Satellite Ephemeris Data.
|
Rtcm1020Data |
Container for RTCM 1020 data.
|
Rtcm1042 |
RTCM 1042 message: Beidou Satellite Ephemeris Data.
|
Rtcm1042Data |
Container for RTCM 1042 data.
|
Rtcm1044 |
RTCM 1044 message: QZSS Satellite Ephemeris Data.
|
Rtcm1044Data |
Container for RTCM 1044 data.
|
Rtcm1045 |
RTCM 1045 message: Galileo F/NAV Satellite Ephemeris Data.
|
Rtcm1045Data |
Container for RTCM 1045 data.
|
RtcmData |
Container for common data in RTCM message.
|
RtcmDataField |
Enum containing all intermediate level data fields that can be parsed
to build a RTCM message.
|
RtcmEphemerisData |
Container for common data in RTCM ephemeris message type.
|
RtcmEphemerisMessage<D extends RtcmEphemerisData> |
Base class for RTCM ephemeris messages.
|
RtcmMessage<D extends RtcmData> |
Base class for RTCM messages.
|
RtcmMessagesParser |
Parser for RTCM encoded messages.
|
RtcmMessageType |
Enum containing the supported RTCM messages types.
|
RTNCovariance |
Container for RTN covariance matrix data.
|
RTNCovarianceKey |
|
RTNCovarianceWriter |
Writer for RTN covariance matrix data block for CCSDS Conjunction Data Messages.
|
SaastamoinenModel |
The modified Saastamoinen model.
|
SatelliteAntenna |
GNSS satellite antenna model.
|
SatelliteClockScale |
Scale for on-board clock.
|
SatelliteSystem |
Enumerate for satellite system.
|
SatelliteType |
Enumerate for satellite types.
|
SBASNavigationMessage |
Container for data contained in a SBAS navigation message.
|
SBASOrbitalElements |
This interface provides the minimal set of orbital elements needed by the SBASPropagator .
|
SBASPropagator |
|
SBASPropagatorBuilder |
This nested class aims at building a SBASPropagator.
|
ScaledConstantThrustPropulsionModel |
Thrust propulsion model with parameters (for estimation) represented by scale factors
on the X, Y and Z axis of the spacecraft frame.
|
Scheduler<T extends ObservedMeasurement<T>> |
|
ScreenType |
Screening type options allowed in CCSDS Conjunction Data Messages.
|
ScreenVolumeFrame |
Screening volume frame possibilities used in CCSDS Conjunction Data Messages.
|
ScreenVolumeShape |
Screening volume shape possibilities used in CCSDS Conjunction Data Messages.
|
Section |
Top level interface for all CCSDS message sections.
|
SecularAndHarmonic |
Class for fitting evolution of osculating orbital parameters.
|
Segment<M extends Metadata,D extends Data> |
|
SemiAnalyticalKalmanEstimator |
Implementation of an Extended Semi-analytical Kalman Filter (ESKF) to perform orbit determination.
|
SemiAnalyticalKalmanEstimatorBuilder |
Builder for a Semi-analytical Kalman Filter.
|
SemiAnalyticalKalmanModel |
|
SemiAnalyticalMeasurementHandler |
|
SemiAnalyticalProcess |
|
SemiAnalyticalUnscentedKalmanEstimator |
Implementation of an Unscented Semi-analytical Kalman filter (USKF) to perform orbit determination.
|
SemiAnalyticalUnscentedKalmanEstimatorBuilder |
Builder for an Unscented Semi-analytical Kalman filter estimator.
|
SemiAnalyticalUnscentedKalmanModel |
|
SEMParser |
This class reads SEM almanac files and provides GPS almanacs .
|
SequentialBatchLSEstimator |
Sequential least squares estimator for orbit determination.
|
SGP4 |
This class contains methods to compute propagated coordinates with the SGP4 model.
|
ShadowModel |
Shadow model for solar radiation pressure.
|
ShapiroInterSatellitePhaseModifier |
Class modifying theoretical inter-satellites phase measurement with Shapiro time delay.
|
ShapiroInterSatelliteRangeModifier |
Class modifying theoretical range measurement with Shapiro time delay.
|
ShapiroOneWayGNSSPhaseModifier |
Class modifying theoretical one-way GNSS phase measurement with Shapiro time delay.
|
ShapiroOneWayGNSSRangeModifier |
Class modifying theoretical range measurement with Shapiro time delay.
|
ShapiroPhaseModifier |
Class modifying theoretical phase measurement with Shapiro time delay.
|
ShapiroRangeModifier |
Class modifying theoretical range measurement with Shapiro time delay.
|
ShiftingTransformProvider |
Transform provider using thread-safe shifts on transforms sample.
|
SHMFormatReader |
Reader for the SHM gravity field format.
|
ShortPeriodicsInterpolatedCoefficient |
Interpolated short periodics coefficients.
|
ShortPeriodTerms |
Additive short period terms contributing to the mean to osculating orbit mapping.
|
SigmaEigenvectorsCovariance |
Container for Sigma/Eigenvectors Covariance data.
|
SigmaEigenvectorsCovarianceKey |
|
SignalCode |
Enumerate for satellite signal code.
|
SignalInSpaceAccuracy |
Signal-In-Space Accuracy (SISA).
|
SignSemantic |
Enumerate for the semantic of the g function sign during measurements generation.
|
SimpleExponentialAtmosphere |
Simple exponential atmospheric model.
|
SimpleRatioAmbiguityAcceptance |
Ambiguity acceptance test based on a ratio of the two best candidates.
|
SimpleTimeStampedTableParser<T extends TimeStamped> |
|
SimpleTimeStampedTableParser.RowConverter<S extends TimeStamped> |
Interface for converting a table row into time-stamped data.
|
SinexEopEntry |
Container for EOP entry read in a Sinex file.
|
SinexLoader |
Loader for Solution INdependent EXchange (SINEX) files.
|
SingleBodyAbsoluteAttraction |
Body attraction force model computed as absolute acceleration towards a body.
|
SingleBodyRelativeAttraction |
Body attraction force model computed as relative acceleration towards frame center.
|
SingleFrequencyHatchFilter |
Single frequency Hatch filter.
|
SingleFrequencySmoother |
Handler to perform pseudo-range smoothing using single frequency measurements.
|
SingleLayerModelMappingFunction |
Single Layer Model (SLM) ionospheric mapping function.
|
SmallManeuverAnalyticalModel |
Analytical model for small maneuvers.
|
SmoothedObservationDataSet |
Container used to store smoothed observation data along with the original data set it originates from.
|
SmoothFieldOfView |
Class representing a spacecraft sensor Field Of View with shape defined by a smooth single loop.
|
SolarRadiationPressure |
Solar radiation pressure force model.
|
SOLFSMYDataLoader |
|
SOLFSMYDataLoader.LineParameters |
Container class for Solar activity indexes.
|
SolidTides |
Solid tides force model.
|
SourceTable |
Source table for ntrip streams retrieval.
|
SP3 |
Represents a parsed SP3 orbit file.
|
SP3.SP3Coordinate |
A single record of position clock and possibly derivatives in an SP3 file.
|
SP3.SP3FileType |
File type indicator.
|
SP3.SP3OrbitType |
Orbit type indicator.
|
SP3Parser |
A parser for the SP3 orbit file format.
|
SpacecraftBodyFrame |
Frames used in CCSDS Attitude Data Messages for the spacecraft body.
|
SpacecraftBodyFrame.BaseEquipment |
Equipment on which the frame is located.
|
SpacecraftParameters |
Container for spacecraft parameters data.
|
SpacecraftParameters |
Container for spacecraft parameters.
|
SpacecraftParametersKey |
|
SpacecraftParametersKey |
|
SpacecraftParametersWriter |
Writer for spacecraft parameters data.
|
SpacecraftState |
This class is the representation of a complete state holding orbit, attitude
and mass information at a given date.
|
SphericalHarmonicsProvider |
Interface used to provide spherical harmonics coefficients.
|
SpinStabilized |
This class handles a spin stabilized attitude provider.
|
SpinStabilized |
Container for Attitude Parameter Message data lines.
|
SpinStabilizedKey |
|
SsrData |
Container for common data in SSR message data.
|
SsrHeader |
Container for common data in SSR messages header.
|
SsrIgm01 |
GNSS SSR Orbit Correction Message.
|
SsrIgm01Data |
Container for SSR IGM01 data.
|
SsrIgm01Header |
Container for SSR IGM01 header.
|
SsrIgm02 |
GNSS SSR Clock Correction Message.
|
SsrIgm02Data |
Container for SSR IGM02 data.
|
SsrIgm02Header |
Container for SSR IGM02 header.
|
SsrIgm03 |
GNSS SSR Combined Orbit and Clock Correction Message.
|
SsrIgm03Data |
Container for SSR IGM03 data.
|
SsrIgm03Header |
Container for SSR IGM03 header.
|
SsrIgm04 |
GNSS SSR High Rate Clock Correction Message.
|
SsrIgm04Data |
Container for SSR IGM04 data.
|
SsrIgm04Header |
Container for SSR IGM04 header.
|
SsrIgm05 |
GNSS SSR Code Bias Message.
|
SsrIgm05Data |
Container for SSR IGM05 data.
|
SsrIgm05Header |
Container for SSR IGM05 header.
|
SsrIgm06 |
GNSS SSR Phase Bias Message.
|
SsrIgm06Data |
Container for SSR IGM06 data.
|
SsrIgm06Header |
Container for SSR IGM06 header.
|
SsrIgm07 |
GNSS SSR SSR URA Message.
|
SsrIgm07Data |
Container for SSR IGM07 data.
|
SsrIgm07Header |
Container for SSR IGM07 header.
|
SsrIgmData |
Container for common data in IGS Generic SSR Message type.
|
SsrIgmHeader |
Container for common data in IGS Generic SSR Message type header.
|
SsrIgmMessage<H extends SsrIgmHeader,D extends SsrIgmData> |
The IGS Generic SSR Message types provide elements
to calculate GNSS satellite corrections.
|
SsrIm201 |
SSR Ionosphere VTEC Spherical Harmonics Message.
|
SsrIm201Data |
Container for SSR IM201 data.
|
SsrIm201Header |
Container for SSR IM201 header.
|
SsrMessage<H extends SsrHeader,D extends SsrData> |
Base class for SSR messages.
|
SsrVtecIonosphericModel |
Ionospheric model based on SSR IM201 message.
|
StartStopEventsTrigger<A extends AbstractDetector<A>,O extends AbstractDetector<O>> |
Maneuver triggers based on a pair of event detectors that defines firing start and stop.
|
StateCovariance |
This class is the representation of a covariance matrix at a given date.
|
StateCovarianceMatrixProvider |
Additional state provider for state covariance matrix.
|
StateFunction |
|
StateJacobian |
Interface representing the Jacobian of a vector function depending on SpacecraftState .
|
StateMapper |
|
StateVector |
Container for state vector data.
|
StateVector |
Container for state vector data.
|
StateVectorKey |
|
StateVectorKey |
|
StateVectorWriter |
Writer for state vector data for CCSDS Conjunction Data Messages.
|
StateVectorWriter |
Writer for state vector data.
|
StaticTransform |
A transform that only includes translation and rotation.
|
Station |
Station model.
|
Station.ReferenceSystem |
Eccentricity reference system.
|
StationDisplacement |
Interface for computing reference points displacement.
|
StepHandlerMultiplexer |
|
STMEquations |
Class calculating the state transition matrix coefficient for CR3BP Computation.
|
StopOnDecreasing<T extends EventDetector> |
Handle a detection event and choose what to do next.
|
StopOnEvent<T extends EventDetector> |
Event handler which will always return stop as a state.
|
StopOnIncreasing<T extends EventDetector> |
Handle a detection event and choose what to do next.
|
StreamedMessage |
Container for streamed messages meta-data.
|
StreamingAemWriter |
A writer for AEM files.
|
StreamingCpfWriter |
A writer for CPF files.
|
StreamingCpfWriter.HeaderLineWriter |
Writer for specific header lines.
|
StreamingOemWriter |
A writer for OEM files.
|
StreamMonitor |
Monitor for retrieving streamed data from one mount point.
|
TabulatedLofOffset |
This class handles an attitude provider interpolating from a predefined table
containing offsets from a Local Orbital Frame.
|
TabulatedProvider |
This class handles an attitude provider interpolating from a predefined table.
|
TAIScale |
International Atomic Time.
|
TAIUTCDatFilesLoader |
Loader for UTC-TAI extracted from tai-utc.dat file from USNO.
|
TAIUTCDatFilesLoader.Parser |
Internal class performing the parsing.
|
TargetPointing |
This class handles target pointing attitude provider.
|
TCBScale |
Barycentric Coordinate Time.
|
TCGScale |
Geocentric Coordinate Time.
|
TDBScale |
Barycentric Dynamic Time.
|
Tdm |
This class stores all the information of the CCSDS Tracking Data Message parsed by TDMParser or TDMXMLParser.
|
TdmDataKey |
|
TdmMetadata |
The TDMMetadata class gathers the meta-data present in the Tracking Data Message (TDM).
|
TdmMetadataKey |
|
TdmParser |
Class for CCSDS Tracking Data Message parsers.
|
TdmWriter |
Writer for CCSDS Tracking Data Message.
|
TDOA |
Class modeling a Time Difference of Arrival measurement with a satellite as emitter
and two ground stations as receivers.
|
TDOABuilder |
Builder for TDOA measurements.
|
TDOAIonosphericDelayModifier |
Class modifying theoretical TDOA measurements with ionospheric delay.
|
TDOATroposphericDelayModifier |
Class modifying theoretical TDOA measurements with tropospheric delay.
|
ThirdBodyAttraction |
Third body attraction force model.
|
ThirdBodyAttractionEpoch |
Third body attraction force model.
|
ThreeEighthesIntegratorBuilder |
Builder for ThreeEighthesIntegrator.
|
ThrustDirectionAndAttitudeProvider |
This class is used in to both manage the attitude of the satellite and the
direction of thrust.
|
ThrustDirectionProvider |
Interface to compute the thrust direction of a maneuver.
|
ThrustPropulsionModel |
Interface for a thrust-based propulsion model.
|
TidalDisplacement |
Modeling of displacement of reference points due to tidal effects.
|
Tide |
Class representing a tide.
|
TideSystem |
Enumerate for tie systems.
|
TideSystemProvider |
|
Tile |
Simple data structure for a quadrilateral tile shape on a body surface.
|
TileAiming |
Interface defining the aiming direction of tiles .
|
TimeComponents |
Class representing a time within the day broken up as hour,
minute and second components.
|
TimeConverter |
Dates reader/writer.
|
TimeDerivativesEquations |
Interface summing up the contribution of several forces into orbit and mass derivatives.
|
TimeInterpolable<T extends TimeInterpolable<T>> |
This interface represents objects that can be interpolated in time.
|
TimeScalarFunction |
This interface represents a scalar function of time.
|
TimeScale |
Interface for time scales.
|
TimeScales |
|
TimeScalesFactory |
Factory for predefined time scales.
|
TimeShiftable<T extends TimeShiftable<T>> |
This interface represents objects that can be shifted in time.
|
TimeSpanDragForce |
Time span atmospheric drag force model.
|
TimeSpanEstimatedTroposphericModel |
Time span estimated tropospheric model.
|
TimeSpanMap<T> |
Container for objects that apply to spans of time.
|
TimeSpanMap.Span<S> |
Holder for one time span.
|
TimeSpanMap.Transition<S> |
Class holding transition times.
|
TimeSpanParametricAcceleration |
Time span parametric acceleration model.
|
TimeStamped |
This interface represents objects that have a AbsoluteDate
date attached to them.
|
TimeStampedAngularCoordinates |
|
TimeStampedCache<T extends TimeStamped> |
Interface for a data structure that can provide concurrent access to
TimeStamped data surrounding a given date.
|
TimeStampedCacheException |
|
TimeStampedFieldAngularCoordinates<T extends CalculusFieldElement<T>> |
|
TimeStampedFieldPVCoordinates<T extends CalculusFieldElement<T>> |
|
TimeStampedGenerator<T extends TimeStamped> |
|
TimeStampedPVCoordinates |
|
TimeSystem |
The set of time systems defined in CCSDS standards (ADM, ODM, NDM).
|
TimeSystem |
Enumerate for the time systems used in navigation files.
|
TimetagReference |
Reference for time tag.
|
TimeVectorFunction |
This interface represents a multi-valued function of time.
|
TLE |
This class is a container for a single set of TLE data.
|
TLEBatchLSModel |
Deprecated.
|
TLEConstants |
Constants necessary to TLE propagation.
|
TLEJacobiansMapper |
|
TLEKalmanModel |
Deprecated.
|
TLEPartialDerivativesEquations |
Deprecated. |
TLEPropagator |
This class provides elements to propagate TLE's.
|
TLEPropagatorBuilder |
Builder for TLEPropagator.
|
TokenType |
Enumerate for tokens occurring during CCSDS file parsing.
|
TopocentricFrame |
Topocentric frame.
|
TrackingMode |
Tracking mode.
|
TrajectoryState |
Trajectory state entry.
|
TrajectoryStateHistory |
Trajectory state history.
|
TrajectoryStateHistoryMetadata |
Metadata for trajectory state history.
|
TrajectoryStateHistoryMetadataKey |
|
Transform |
Transformation class in three dimensional space.
|
TransformGenerator |
|
TransformProvider |
Interface for Transform providers.
|
TransformProviderUtils |
Utility for Transform providers.
|
TriggerDate |
Generator for one column of a Jacobian matrix for special case of trigger dates.
|
TroposphericGradientConverter |
Deprecated.
|
TroposphericModelUtils |
Utility class for tropospheric models.
|
TTScale |
Terrestrial Time as defined by IAU(1991) recommendation IV.
|
TurnAroundRange |
Class modeling a turn-around range measurement using a primary ground station and a secondary ground station.
|
TurnAroundRangeBuilder |
|
TurnAroundRangeIonosphericDelayModifier |
Class modifying theoretical TurnAroundRange measurement with ionospheric delay.
|
TurnAroundRangeTroposphericDelayModifier |
Class modifying theoretical turn-around TurnAroundRange measurement with tropospheric delay.
|
TwoBodiesBaryFrame |
Class creating the inertial barycenter frame from two bodies.
|
Type |
Enumerate for messages type.
|
Unit |
Basic handling of multiplicative units.
|
Units |
Units used in CCSDS messages.
|
Units |
Units used in RTCM and IGS SSR messages.
|
UnitsCache |
Cache for parsed units.
|
UnitsConverter |
Converter between units.
|
UnivariateProcessNoise |
Provider for a temporal evolution of the process noise matrix.
|
UnixCompressFilter |
Filter for Unix compressed data.
|
UnnormalizedSphericalHarmonicsProvider |
Interface used to provide un-normalized spherical harmonics coefficients.
|
UnnormalizedSphericalHarmonicsProvider.UnnormalizedSphericalHarmonics |
Un-normalized spherical harmonics coefficients evaluated at a specific instant.
|
UnscentedKalmanEstimator |
Implementation of an Unscented Kalman filter to perform orbit determination.
|
UnscentedKalmanEstimatorBuilder |
Builder for an Unscented Kalman filter estimator.
|
UnscentedKalmanModel |
|
UpdatableFrame |
Frame whose transform from its parent can be updated.
|
UpperBounds |
Utility class to compute upper bounds for truncation algorithms.
|
UserDefined |
Container for user defined data.
|
UserDefinedWriter |
Writer for user defined parameters data.
|
UserDefinedXmlTokenBuilder |
Builder for user-defined parameters.
|
UserRangeAccuracy |
User Range Accuracy.
|
UT1Scale |
Universal Time 1.
|
UTCScale |
Coordinated Universal Time.
|
UTCTAIBulletinAFilesLoader |
Loader for UTC-TAI extracted from bulletin A files.
|
UTCTAIHistoryFilesLoader |
Loader for UTC versus TAI history files.
|
UTCTAIHistoryFilesLoader.Parser |
Internal class performing the parsing.
|
UTCTAIOffset |
Offset between UTC and TAI time scales.
|
UTCTAIOffsetsLoader |
Interface for loading UTC-TAI offsets data files.
|
UTCTAIOffsetsLoader.Parser |
Interface for parsing UTC-TAI offsets from a stream.
|
VersionedITRF |
Specific version of International Terrestrial Reference Frame.
|
ViennaModelCoefficientsLoader |
Loads Vienna tropospheric coefficients a given input stream.
|
ViennaModelType |
Enumerate for Vienna tropospheric model 1 and 3.
|
ViennaOneModel |
The Vienna1 tropospheric delay model for radio techniques.
|
ViennaThreeModel |
The Vienna3 tropospheric delay model for radio techniques.
|
VisibilityTrigger |
Enumerate for triggering visibility of spherical bodies.
|
WaypointPVBuilder |
Builder class, enabling incremental building of an PVCoordinatesProvider
instance using waypoints defined on an ellipsoid.
|
WaypointPVBuilder.InterpolationFactory |
|
WeatherModel |
Defines a surface meteorology model that can be used to
compute the different weather parameters (pressure, temperature, ...).
|
WideLaneCombination |
Wide-Lane combination.
|
WindUp |
|
WindUpFactory |
|
WriterBuilder |
|
XmlGenerator |
Generator for eXtended Markup Language CCSDS messages.
|
XmlLexicalAnalyzer |
Lexical analyzer for XML CCSDS messages.
|
XmlStructureKey |
|
XmlStructureProcessingState |
|
XmlSubStructureKey |
Keywords for CDM data sub-structure in XML files.
|
XmlTokenBuilder |
Builder for building ParseToken from XML elements.
|
XYZCovariance |
Container for XYZ covariance matrix data.
|
XYZCovarianceKey |
|
YawCompensation |
This class handles yaw compensation attitude provider.
|
YawSteering |
This class handles yaw steering law.
|
YesNoUnknown |
Yes, No, Unknown values for various elements.
|
YUMAParser |
This class reads Yuma almanac files and provides GPS almanacs .
|
ZipJarCrawler |
Helper class for loading data files from a zip/jar archive.
|