Uses of Interface
org.apache.commons.math3.RealFieldElement
Packages that use RealFieldElement
Package
Description
Parent package for common numerical analysis procedures, including root finding,
function interpolation and integration.
This package holds the main interfaces and basic building block classes
dealing with differentiation.
Root finding algorithms, for univariate real functions.
Decimal floating point library for Java
This package provides basic 3D geometry components.
This package provides classes to solve Ordinary Differential Equations problems.
This package provides classes to handle discrete events occurring during
Ordinary Differential Equations integration.
This package provides classes to solve non-stiff Ordinary Differential Equations problems.
This package provides classes to handle sampling steps during
Ordinary Differential Equations integration.
Convenience routines and common data structures used throughout the commons-math library.
-
Uses of RealFieldElement in org.apache.commons.math3.analysis
Classes in org.apache.commons.math3.analysis with type parameters of type RealFieldElementModifier and TypeInterfaceDescriptioninterface
RealFieldUnivariateFunction<T extends RealFieldElement<T>>
An interface representing a univariate real function. -
Uses of RealFieldElement in org.apache.commons.math3.analysis.differentiation
Classes in org.apache.commons.math3.analysis.differentiation that implement RealFieldElementModifier and TypeClassDescriptionclass
Class representing both the value and the differentials of a function.class
First derivative computation with large number of variables. -
Uses of RealFieldElement in org.apache.commons.math3.analysis.solvers
Classes in org.apache.commons.math3.analysis.solvers with type parameters of type RealFieldElementModifier and TypeInterfaceDescriptioninterface
BracketedRealFieldUnivariateSolver<T extends RealFieldElement<T>>
Interface for(univariate real) root-finding algorithms
that maintain a bracketed solution.class
FieldBracketingNthOrderBrentSolver<T extends RealFieldElement<T>>
This class implements a modification of the Brent algorithm. -
Uses of RealFieldElement in org.apache.commons.math3.dfp
Classes in org.apache.commons.math3.dfp that implement RealFieldElement -
Uses of RealFieldElement in org.apache.commons.math3.geometry.euclidean.threed
Classes in org.apache.commons.math3.geometry.euclidean.threed with type parameters of type RealFieldElementModifier and TypeClassDescriptionclass
FieldRotation<T extends RealFieldElement<T>>
This class is a re-implementation ofRotation
usingRealFieldElement
.class
FieldVector3D<T extends RealFieldElement<T>>
This class is a re-implementation ofVector3D
usingRealFieldElement
.Methods in org.apache.commons.math3.geometry.euclidean.threed with type parameters of type RealFieldElementModifier and TypeMethodDescriptionstatic <T extends RealFieldElement<T>>
TFieldVector3D.angle
(FieldVector3D<T> v1, FieldVector3D<T> v2) Compute the angular separation between two vectors.static <T extends RealFieldElement<T>>
TFieldVector3D.angle
(FieldVector3D<T> v1, Vector3D v2) Compute the angular separation between two vectors.static <T extends RealFieldElement<T>>
TFieldVector3D.angle
(Vector3D v1, FieldVector3D<T> v2) Compute the angular separation between two vectors.static <T extends RealFieldElement<T>>
FieldRotation<T> FieldRotation.applyInverseTo
(Rotation rOuter, FieldRotation<T> rInner) Apply the inverse of a rotation to another rotation.static <T extends RealFieldElement<T>>
FieldVector3D<T> FieldRotation.applyInverseTo
(Rotation r, FieldVector3D<T> u) Apply the inverse of a rotation to a vector.static <T extends RealFieldElement<T>>
FieldRotation<T> FieldRotation.applyTo
(Rotation r1, FieldRotation<T> rInner) Apply a rotation to another rotation.static <T extends RealFieldElement<T>>
FieldVector3D<T> FieldRotation.applyTo
(Rotation r, FieldVector3D<T> u) Apply a rotation to a vector.static <T extends RealFieldElement<T>>
FieldVector3D<T> FieldVector3D.crossProduct
(FieldVector3D<T> v1, FieldVector3D<T> v2) Compute the cross-product of two vectors.static <T extends RealFieldElement<T>>
FieldVector3D<T> FieldVector3D.crossProduct
(FieldVector3D<T> v1, Vector3D v2) Compute the cross-product of two vectors.static <T extends RealFieldElement<T>>
FieldVector3D<T> FieldVector3D.crossProduct
(Vector3D v1, FieldVector3D<T> v2) Compute the cross-product of two vectors.static <T extends RealFieldElement<T>>
TFieldRotation.distance
(FieldRotation<T> r1, FieldRotation<T> r2) Compute the distance between two rotations.static <T extends RealFieldElement<T>>
TFieldVector3D.distance
(FieldVector3D<T> v1, FieldVector3D<T> v2) Compute the distance between two vectors according to the L2 norm.static <T extends RealFieldElement<T>>
TFieldVector3D.distance
(FieldVector3D<T> v1, Vector3D v2) Compute the distance between two vectors according to the L2 norm.static <T extends RealFieldElement<T>>
TFieldVector3D.distance
(Vector3D v1, FieldVector3D<T> v2) Compute the distance between two vectors according to the L2 norm.static <T extends RealFieldElement<T>>
TFieldVector3D.distance1
(FieldVector3D<T> v1, FieldVector3D<T> v2) Compute the distance between two vectors according to the L1 norm.static <T extends RealFieldElement<T>>
TFieldVector3D.distance1
(FieldVector3D<T> v1, Vector3D v2) Compute the distance between two vectors according to the L1 norm.static <T extends RealFieldElement<T>>
TFieldVector3D.distance1
(Vector3D v1, FieldVector3D<T> v2) Compute the distance between two vectors according to the L1 norm.static <T extends RealFieldElement<T>>
TFieldVector3D.distanceInf
(FieldVector3D<T> v1, FieldVector3D<T> v2) Compute the distance between two vectors according to the L∞ norm.static <T extends RealFieldElement<T>>
TFieldVector3D.distanceInf
(FieldVector3D<T> v1, Vector3D v2) Compute the distance between two vectors according to the L∞ norm.static <T extends RealFieldElement<T>>
TFieldVector3D.distanceInf
(Vector3D v1, FieldVector3D<T> v2) Compute the distance between two vectors according to the L∞ norm.static <T extends RealFieldElement<T>>
TFieldVector3D.distanceSq
(FieldVector3D<T> v1, FieldVector3D<T> v2) Compute the square of the distance between two vectors.static <T extends RealFieldElement<T>>
TFieldVector3D.distanceSq
(FieldVector3D<T> v1, Vector3D v2) Compute the square of the distance between two vectors.static <T extends RealFieldElement<T>>
TFieldVector3D.distanceSq
(Vector3D v1, FieldVector3D<T> v2) Compute the square of the distance between two vectors.static <T extends RealFieldElement<T>>
TFieldVector3D.dotProduct
(FieldVector3D<T> v1, FieldVector3D<T> v2) Compute the dot-product of two vectors.static <T extends RealFieldElement<T>>
TFieldVector3D.dotProduct
(FieldVector3D<T> v1, Vector3D v2) Compute the dot-product of two vectors.static <T extends RealFieldElement<T>>
TFieldVector3D.dotProduct
(Vector3D v1, FieldVector3D<T> v2) Compute the dot-product of two vectors.Methods in org.apache.commons.math3.geometry.euclidean.threed that return RealFieldElementModifier and TypeMethodDescriptionT[]
FieldRotation.getAngles
(RotationOrder order) Deprecated.T[]
FieldRotation.getAngles
(RotationOrder order, RotationConvention convention) Get the Cardan or Euler angles corresponding to the instance.T[][]
FieldRotation.getMatrix()
Get the 3X3 matrix corresponding to the instanceT[]
FieldVector3D.toArray()
Get the vector coordinates as a dimension 3 array.Methods in org.apache.commons.math3.geometry.euclidean.threed with parameters of type RealFieldElementModifier and TypeMethodDescriptionvoid
FieldRotation.applyInverseTo
(double[] in, T[] out) Apply the inverse of the rotation to a vector stored in an array.void
FieldRotation.applyInverseTo
(T[] in, T[] out) Apply the inverse of the rotation to a vector stored in an array.void
Apply the rotation to a vector stored in an array.void
Apply the rotation to a vector stored in an array.Constructors in org.apache.commons.math3.geometry.euclidean.threed with parameters of type RealFieldElementModifierConstructorDescriptionFieldRotation
(T[][] m, double threshold) Build a rotation from a 3X3 matrix.FieldVector3D
(T[] v) Simple constructor. -
Uses of RealFieldElement in org.apache.commons.math3.ode
Classes in org.apache.commons.math3.ode with type parameters of type RealFieldElementModifier and TypeClassDescriptionclass
AbstractFieldIntegrator<T extends RealFieldElement<T>>
Base class managing common boilerplate for all integrators.class
ContinuousOutputFieldModel<T extends RealFieldElement<T>>
This class stores all information provided by an ODE integrator during the integration process and build a continuous model of the solution from this.class
FieldEquationsMapper<T extends RealFieldElement<T>>
Class mapping the part of a complete state or derivative that pertains to a set of differential equations.class
FieldExpandableODE<T extends RealFieldElement<T>>
This class represents a combined set of first order differential equations, with at least a primary set of equations expandable by some sets of secondary equations.class
FieldODEState<T extends RealFieldElement<T>>
Container for time, main and secondary state vectors.class
FieldODEStateAndDerivative<T extends RealFieldElement<T>>
Container for time, main and secondary state vectors as well as their derivatives.interface
FieldSecondaryEquations<T extends RealFieldElement<T>>
This interface allows users to add secondary differential equations to a primary set of differential equations.interface
FirstOrderFieldDifferentialEquations<T extends RealFieldElement<T>>
This interface represents a first order differential equations set.interface
FirstOrderFieldIntegrator<T extends RealFieldElement<T>>
This interface represents a first order integrator for differential equations.class
MultistepFieldIntegrator<T extends RealFieldElement<T>>
This class is the base class for multistep integrators for Ordinary Differential Equations.Fields in org.apache.commons.math3.ode declared as RealFieldElementModifier and TypeFieldDescriptionprotected T[]
MultistepFieldIntegrator.scaled
First scaled derivative (h y').Methods in org.apache.commons.math3.ode that return RealFieldElementModifier and TypeMethodDescriptionT[]
AbstractFieldIntegrator.computeDerivatives
(T t, T[] y) Compute the derivatives and check the number of evaluations.T[]
FieldExpandableODE.computeDerivatives
(T t, T[] y) Get the current time derivative of the complete state vector.T[]
FieldSecondaryEquations.computeDerivatives
(T t, T[] primary, T[] primaryDot, T[] secondary) Compute the derivatives related to the secondary state parameters.T[]
FirstOrderFieldDifferentialEquations.computeDerivatives
(T t, T[] y) Get the current time derivative of the state vector.protected T[][]
Copy a two-dimensions array.T[]
FieldEquationsMapper.extractEquationData
(int index, T[] complete) Extract equation data from a complete state or derivative array.T[]
FieldODEStateAndDerivative.getDerivative()
Get derivative of the main state at time.T[]
FieldODEStateAndDerivative.getSecondaryDerivative
(int index) Get derivative of the secondary state at time.T[]
FieldODEState.getSecondaryState
(int index) Get secondary state at time.T[]
FieldODEState.getState()
Get main state at time.T[]
FieldEquationsMapper.mapDerivative
(FieldODEStateAndDerivative<T> state) Map a state derivative to a complete flat array.T[]
FieldEquationsMapper.mapState
(FieldODEState<T> state) Map a state to a complete flat array.Methods in org.apache.commons.math3.ode with parameters of type RealFieldElementModifier and TypeMethodDescriptionT[]
AbstractFieldIntegrator.computeDerivatives
(T t, T[] y) Compute the derivatives and check the number of evaluations.T[]
FieldExpandableODE.computeDerivatives
(T t, T[] y) Get the current time derivative of the complete state vector.T[]
FieldSecondaryEquations.computeDerivatives
(T t, T[] primary, T[] primaryDot, T[] secondary) Compute the derivatives related to the secondary state parameters.T[]
FirstOrderFieldDifferentialEquations.computeDerivatives
(T t, T[] y) Get the current time derivative of the state vector.protected T[][]
Copy a two-dimensions array.T[]
FieldEquationsMapper.extractEquationData
(int index, T[] complete) Extract equation data from a complete state or derivative array.void
Initialize equations at the start of an ODE integration.void
Initialize equations at the start of an ODE integration.void
Initialize equations at the start of an ODE integration.protected abstract Array2DRowFieldMatrix
<T> MultistepFieldIntegrator.initializeHighOrderDerivatives
(T h, T[] t, T[][] y, T[][] yDot) Initialize the high order scaled derivatives at step start.protected FieldODEStateAndDerivative
<T> AbstractFieldIntegrator.initIntegration
(FieldExpandableODE<T> eqn, T t0, T[] y0, T t) Prepare the start of an integration.void
FieldEquationsMapper.insertEquationData
(int index, T[] equationData, T[] complete) Insert equation data into a complete state or derivative array.FieldEquationsMapper.mapStateAndDerivative
(T t, T[] y, T[] yDot) Map flat arrays to a state and derivative.Constructors in org.apache.commons.math3.ode with parameters of type RealFieldElementModifierConstructorDescriptionFieldODEState
(T time, T[] state) Simple constructor.FieldODEState
(T time, T[] state, T[][] secondaryState) Simple constructor.FieldODEStateAndDerivative
(T time, T[] state, T[] derivative) Simple constructor.FieldODEStateAndDerivative
(T time, T[] state, T[] derivative, T[][] secondaryState, T[][] secondaryDerivative) Simple constructor. -
Uses of RealFieldElement in org.apache.commons.math3.ode.events
Classes in org.apache.commons.math3.ode.events with type parameters of type RealFieldElementModifier and TypeInterfaceDescriptioninterface
FieldEventHandler<T extends RealFieldElement<T>>
This interface represents a handler for discrete events triggered during ODE integration.class
FieldEventState<T extends RealFieldElement<T>>
This class handles the state for oneevent handler
during integration steps. -
Uses of RealFieldElement in org.apache.commons.math3.ode.nonstiff
Classes in org.apache.commons.math3.ode.nonstiff with type parameters of type RealFieldElementModifier and TypeClassDescriptionclass
AdamsBashforthFieldIntegrator<T extends RealFieldElement<T>>
This class implements explicit Adams-Bashforth integrators for Ordinary Differential Equations.class
AdamsFieldIntegrator<T extends RealFieldElement<T>>
Base class forAdams-Bashforth
andAdams-Moulton
integrators.class
AdamsMoultonFieldIntegrator<T extends RealFieldElement<T>>
This class implements implicit Adams-Moulton integrators for Ordinary Differential Equations.class
AdamsNordsieckFieldTransformer<T extends RealFieldElement<T>>
Transformer to Nordsieck vectors for Adams integrators.class
AdaptiveStepsizeFieldIntegrator<T extends RealFieldElement<T>>
This abstract class holds the common part of all adaptive stepsize integrators for Ordinary Differential Equations.class
ClassicalRungeKuttaFieldIntegrator<T extends RealFieldElement<T>>
This class implements the classical fourth order Runge-Kutta integrator for Ordinary Differential Equations (it is the most often used Runge-Kutta method).class
DormandPrince54FieldIntegrator<T extends RealFieldElement<T>>
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.class
DormandPrince853FieldIntegrator<T extends RealFieldElement<T>>
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.class
EmbeddedRungeKuttaFieldIntegrator<T extends RealFieldElement<T>>
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.class
EulerFieldIntegrator<T extends RealFieldElement<T>>
This class implements a simple Euler integrator for Ordinary Differential Equations.interface
FieldButcherArrayProvider<T extends RealFieldElement<T>>
This interface represents an integrator based on Butcher arrays.class
GillFieldIntegrator<T extends RealFieldElement<T>>
This class implements the Gill fourth order Runge-Kutta integrator for Ordinary Differential Equations .class
HighamHall54FieldIntegrator<T extends RealFieldElement<T>>
This class implements the 5(4) Higham and Hall integrator for Ordinary Differential Equations.class
LutherFieldIntegrator<T extends RealFieldElement<T>>
This class implements the Luther sixth order Runge-Kutta integrator for Ordinary Differential Equations.class
MidpointFieldIntegrator<T extends RealFieldElement<T>>
This class implements a second order Runge-Kutta integrator for Ordinary Differential Equations.class
RungeKuttaFieldIntegrator<T extends RealFieldElement<T>>
This class implements the common part of all fixed step Runge-Kutta integrators for Ordinary Differential Equations.class
ThreeEighthesFieldIntegrator<T extends RealFieldElement<T>>
This class implements the 3/8 fourth order Runge-Kutta integrator for Ordinary Differential Equations.Methods in org.apache.commons.math3.ode.nonstiff with type parameters of type RealFieldElementModifier and TypeMethodDescriptionstatic <T extends RealFieldElement<T>>
AdamsNordsieckFieldTransformer<T> AdamsNordsieckFieldTransformer.getInstance
(Field<T> field, int nSteps) Get the Nordsieck transformer for a given field and number of steps.Methods in org.apache.commons.math3.ode.nonstiff that return RealFieldElementModifier and TypeMethodDescriptionT[][]
ClassicalRungeKuttaFieldIntegrator.getA()
Get the internal weights from Butcher array (without the first empty row).T[][]
DormandPrince54FieldIntegrator.getA()
Get the internal weights from Butcher array (without the first empty row).T[][]
DormandPrince853FieldIntegrator.getA()
Get the internal weights from Butcher array (without the first empty row).T[][]
EulerFieldIntegrator.getA()
Get the internal weights from Butcher array (without the first empty row).T[][]
FieldButcherArrayProvider.getA()
Get the internal weights from Butcher array (without the first empty row).T[][]
GillFieldIntegrator.getA()
Get the internal weights from Butcher array (without the first empty row).T[][]
HighamHall54FieldIntegrator.getA()
Get the internal weights from Butcher array (without the first empty row).T[][]
LutherFieldIntegrator.getA()
Get the internal weights from Butcher array (without the first empty row).T[][]
MidpointFieldIntegrator.getA()
Get the internal weights from Butcher array (without the first empty row).T[][]
ThreeEighthesFieldIntegrator.getA()
Get the internal weights from Butcher array (without the first empty row).T[]
ClassicalRungeKuttaFieldIntegrator.getB()
Get the external weights for the high order method from Butcher array.T[]
DormandPrince54FieldIntegrator.getB()
Get the external weights for the high order method from Butcher array.T[]
DormandPrince853FieldIntegrator.getB()
Get the external weights for the high order method from Butcher array.T[]
EulerFieldIntegrator.getB()
Get the external weights for the high order method from Butcher array.T[]
FieldButcherArrayProvider.getB()
Get the external weights for the high order method from Butcher array.T[]
GillFieldIntegrator.getB()
Get the external weights for the high order method from Butcher array.T[]
HighamHall54FieldIntegrator.getB()
Get the external weights for the high order method from Butcher array.T[]
LutherFieldIntegrator.getB()
Get the external weights for the high order method from Butcher array.T[]
MidpointFieldIntegrator.getB()
Get the external weights for the high order method from Butcher array.T[]
ThreeEighthesFieldIntegrator.getB()
Get the external weights for the high order method from Butcher array.T[]
ClassicalRungeKuttaFieldIntegrator.getC()
Get the time steps from Butcher array (without the first zero).T[]
DormandPrince54FieldIntegrator.getC()
Get the time steps from Butcher array (without the first zero).T[]
DormandPrince853FieldIntegrator.getC()
Get the time steps from Butcher array (without the first zero).T[]
EulerFieldIntegrator.getC()
Get the time steps from Butcher array (without the first zero).T[]
FieldButcherArrayProvider.getC()
Get the time steps from Butcher array (without the first zero).T[]
GillFieldIntegrator.getC()
Get the time steps from Butcher array (without the first zero).T[]
HighamHall54FieldIntegrator.getC()
Get the time steps from Butcher array (without the first zero).T[]
LutherFieldIntegrator.getC()
Get the time steps from Butcher array (without the first zero).T[]
MidpointFieldIntegrator.getC()
Get the time steps from Butcher array (without the first zero).T[]
ThreeEighthesFieldIntegrator.getC()
Get the time steps from Butcher array (without the first zero).T[]
RungeKuttaFieldIntegrator.singleStep
(FirstOrderFieldDifferentialEquations<T> equations, T t0, T[] y0, T t) Fast computation of a single step of ODE integration.Methods in org.apache.commons.math3.ode.nonstiff with parameters of type RealFieldElementModifier and TypeMethodDescriptionprotected org.apache.commons.math3.ode.nonstiff.ClassicalRungeKuttaFieldStepInterpolator
<T> ClassicalRungeKuttaFieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected org.apache.commons.math3.ode.nonstiff.DormandPrince54FieldStepInterpolator
<T> DormandPrince54FieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected org.apache.commons.math3.ode.nonstiff.DormandPrince853FieldStepInterpolator
<T> DormandPrince853FieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected abstract org.apache.commons.math3.ode.nonstiff.RungeKuttaFieldStepInterpolator
<T> EmbeddedRungeKuttaFieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected org.apache.commons.math3.ode.nonstiff.EulerFieldStepInterpolator
<T> EulerFieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected org.apache.commons.math3.ode.nonstiff.GillFieldStepInterpolator
<T> GillFieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected org.apache.commons.math3.ode.nonstiff.HighamHall54FieldStepInterpolator
<T> HighamHall54FieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected org.apache.commons.math3.ode.nonstiff.LutherFieldStepInterpolator
<T> LutherFieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected org.apache.commons.math3.ode.nonstiff.MidpointFieldStepInterpolator
<T> MidpointFieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected abstract org.apache.commons.math3.ode.nonstiff.RungeKuttaFieldStepInterpolator
<T> RungeKuttaFieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected org.apache.commons.math3.ode.nonstiff.ThreeEighthesFieldStepInterpolator
<T> ThreeEighthesFieldIntegrator.createInterpolator
(boolean forward, T[][] yDotK, FieldODEStateAndDerivative<T> globalPreviousState, FieldODEStateAndDerivative<T> globalCurrentState, FieldEquationsMapper<T> mapper) Create an interpolator.protected T
DormandPrince54FieldIntegrator.estimateError
(T[][] yDotK, T[] y0, T[] y1, T h) Compute the error ratio.protected T
DormandPrince853FieldIntegrator.estimateError
(T[][] yDotK, T[] y0, T[] y1, T h) Compute the error ratio.protected abstract T
EmbeddedRungeKuttaFieldIntegrator.estimateError
(T[][] yDotK, T[] y0, T[] y1, T h) Compute the error ratio.protected T
HighamHall54FieldIntegrator.estimateError
(T[][] yDotK, T[] y0, T[] y1, T h) Compute the error ratio.protected Array2DRowFieldMatrix
<T> AdamsFieldIntegrator.initializeHighOrderDerivatives
(T h, T[] t, T[][] y, T[][] yDot) Initialize the high order scaled derivatives at step start.AdamsNordsieckFieldTransformer.initializeHighOrderDerivatives
(T h, T[] t, T[][] y, T[][] yDot) Initialize the high order scaled derivatives at step start.AdaptiveStepsizeFieldIntegrator.initializeStep
(boolean forward, int order, T[] scale, FieldODEStateAndDerivative<T> state0, FieldEquationsMapper<T> mapper) Initialize the integration step.T[]
RungeKuttaFieldIntegrator.singleStep
(FirstOrderFieldDifferentialEquations<T> equations, T t0, T[] y0, T t) Fast computation of a single step of ODE integration.void
AdamsFieldIntegrator.updateHighOrderDerivativesPhase2
(T[] start, T[] end, Array2DRowFieldMatrix<T> highOrder) Update the high order scaled derivatives Adams integrators (phase 2).void
AdamsNordsieckFieldTransformer.updateHighOrderDerivativesPhase2
(T[] start, T[] end, Array2DRowFieldMatrix<T> highOrder) Update the high order scaled derivatives Adams integrators (phase 2). -
Uses of RealFieldElement in org.apache.commons.math3.ode.sampling
Classes in org.apache.commons.math3.ode.sampling with type parameters of type RealFieldElementModifier and TypeClassDescriptionclass
AbstractFieldStepInterpolator<T extends RealFieldElement<T>>
This abstract class represents an interpolator over the last step during an ODE integration.interface
FieldFixedStepHandler<T extends RealFieldElement<T>>
This interface represents a handler that should be called after each successful fixed step.interface
FieldStepHandler<T extends RealFieldElement<T>>
This interface represents a handler that should be called after each successful step.interface
FieldStepInterpolator<T extends RealFieldElement<T>>
This interface represents an interpolator over the last step during an ODE integration.class
FieldStepNormalizer<T extends RealFieldElement<T>>
This class wraps an object implementingFieldFixedStepHandler
into aFieldStepHandler
. -
Uses of RealFieldElement in org.apache.commons.math3.util
Classes in org.apache.commons.math3.util that implement RealFieldElementMethods in org.apache.commons.math3.util with type parameters of type RealFieldElementModifier and TypeMethodDescriptionstatic <T extends RealFieldElement<T>>
TMathUtils.max
(T e1, T e2) Find the maximum of two field elements.static <T extends RealFieldElement<T>>
TMathUtils.min
(T e1, T e2) Find the minimum of two field elements.
FieldRotation.getAngles(RotationOrder, RotationConvention)