- ABOVE_SIDE - org.hipparchus.analysis.solvers.AllowedSolution
-
Only solutions for which values are greater than or equal to zero are
acceptable as solutions for root-finding.
- abs() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
absolute value.
- abs() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
absolute value.
- abs() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
absolute value.
- abs() - Method in class org.hipparchus.complex.Complex
-
Return the absolute value of this complex number.
- abs() - Method in class org.hipparchus.dfp.Dfp
-
Get the absolute value of instance.
- abs() - Method in class org.hipparchus.fraction.BigFraction
-
- abs() - Method in class org.hipparchus.fraction.Fraction
-
Returns the absolute value of this fraction.
- abs() - Method in interface org.hipparchus.RealFieldElement
-
absolute value.
- abs() - Method in class org.hipparchus.util.Decimal64
-
absolute value.
- abs() - Method in class org.hipparchus.util.FieldTuple
-
absolute value.
- abs() - Method in class org.hipparchus.util.Tuple
-
absolute value.
- abs(double) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- abs(float) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- abs(int) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- abs(long) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- abs(T) - Static method in class org.hipparchus.util.FastMath
-
Absolute value.
- Abs - Class in org.hipparchus.analysis.function
-
Absolute value function.
- Abs() - Constructor for class org.hipparchus.analysis.function.Abs
-
- AbstractConvergenceChecker<PAIR> - Class in org.hipparchus.optim
-
Base class for all convergence checker implementations.
- AbstractConvergenceChecker(double, double) - Constructor for class org.hipparchus.optim.AbstractConvergenceChecker
-
Build an instance with a specified thresholds.
- AbstractCurveFitter - Class in org.hipparchus.fitting
-
Base class that contains common code for fitting parametric univariate
real functions y = f(pi;x)
, where x
is
the independent variable and the pi
are the
parameters.
- AbstractCurveFitter() - Constructor for class org.hipparchus.fitting.AbstractCurveFitter
-
- AbstractCurveFitter.TheoreticalValuesFunction - Class in org.hipparchus.fitting
-
Vector function for computing function theoretical values.
- AbstractEvaluation - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
- AbstractFieldIntegrator<T extends RealFieldElement<T>> - Class in org.hipparchus.ode
-
Base class managing common boilerplate for all integrators.
- AbstractFieldIntegrator(Field<T>, String) - Constructor for class org.hipparchus.ode.AbstractFieldIntegrator
-
Build an instance.
- AbstractFieldMatrix<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Basic implementation of
FieldMatrix
methods regardless of the underlying storage.
- AbstractFieldMatrix() - Constructor for class org.hipparchus.linear.AbstractFieldMatrix
-
Constructor for use with Serializable
- AbstractFieldMatrix(Field<T>) - Constructor for class org.hipparchus.linear.AbstractFieldMatrix
-
Creates a matrix with no data
- AbstractFieldMatrix(Field<T>, int, int) - Constructor for class org.hipparchus.linear.AbstractFieldMatrix
-
Create a new FieldMatrix with the supplied row and column dimensions.
- AbstractFieldODEStateInterpolator<T extends RealFieldElement<T>> - Class in org.hipparchus.ode.sampling
-
This abstract class represents an interpolator over the last step
during an ODE integration.
- AbstractFieldODEStateInterpolator(boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Constructor for class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Simple constructor.
- AbstractIntegerDistribution - Class in org.hipparchus.distribution.discrete
-
Base class for integer-valued discrete distributions.
- AbstractIntegerDistribution() - Constructor for class org.hipparchus.distribution.discrete.AbstractIntegerDistribution
-
- AbstractIntegrator - Class in org.hipparchus.ode
-
Base class managing common boilerplate for all integrators.
- AbstractIntegrator(String) - Constructor for class org.hipparchus.ode.AbstractIntegrator
-
Build an instance.
- AbstractKalmanFilter<T extends Measurement> - Class in org.hipparchus.filtering.kalman
-
Shared parts between linear and non-linear Kalman filters.
- AbstractKalmanFilter(MatrixDecomposer, ProcessEstimate) - Constructor for class org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Simple constructor.
- AbstractMultipleLinearRegression - Class in org.hipparchus.stat.regression
-
Abstract base class for implementations of MultipleLinearRegression.
- AbstractMultipleLinearRegression() - Constructor for class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
- AbstractMultivariateRealDistribution - Class in org.hipparchus.distribution.multivariate
-
Base class for multivariate probability distributions.
- AbstractMultivariateRealDistribution(RandomGenerator, int) - Constructor for class org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
-
- AbstractODEStateInterpolator - Class in org.hipparchus.ode.sampling
-
This abstract class represents an interpolator over the last step
during an ODE integration.
- AbstractODEStateInterpolator(boolean, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Constructor for class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Simple constructor.
- AbstractOptimizationProblem<PAIR> - Class in org.hipparchus.optim
-
Base class for implementing optimization problems.
- AbstractOptimizationProblem(int, int, ConvergenceChecker<PAIR>) - Constructor for class org.hipparchus.optim.AbstractOptimizationProblem
-
- AbstractParameterizable - Class in org.hipparchus.ode
-
This abstract class provides boilerplate parameters list.
- AbstractParameterizable(String...) - Constructor for class org.hipparchus.ode.AbstractParameterizable
-
Simple constructor.
- AbstractParameterizable(Collection<String>) - Constructor for class org.hipparchus.ode.AbstractParameterizable
-
Simple constructor.
- AbstractPolynomialSolver - Class in org.hipparchus.analysis.solvers
-
Base class for solvers.
- AbstractPolynomialSolver(double) - Constructor for class org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given absolute accuracy.
- AbstractPolynomialSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given accuracies.
- AbstractPolynomialSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Construct a solver with given accuracies.
- AbstractRealDistribution - Class in org.hipparchus.distribution.continuous
-
Base class for probability distributions on the reals.
- AbstractRealDistribution() - Constructor for class org.hipparchus.distribution.continuous.AbstractRealDistribution
-
Create a real distribution with default solver absolute accuracy.
- AbstractRealDistribution(double) - Constructor for class org.hipparchus.distribution.continuous.AbstractRealDistribution
-
- AbstractRealMatrix - Class in org.hipparchus.linear
-
Basic implementation of RealMatrix methods regardless of the underlying storage.
- AbstractRealMatrix() - Constructor for class org.hipparchus.linear.AbstractRealMatrix
-
Creates a matrix with no data
- AbstractRealMatrix(int, int) - Constructor for class org.hipparchus.linear.AbstractRealMatrix
-
Create a new RealMatrix with the supplied row and column dimensions.
- AbstractRegion<S extends Space,T extends Space> - Class in org.hipparchus.geometry.partitioning
-
Abstract class for all regions, independently of geometry type or dimension.
- AbstractRegion(double) - Constructor for class org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a region representing the whole space.
- AbstractRegion(Collection<SubHyperplane<S>>, double) - Constructor for class org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a Region from a Boundary REPresentation (B-rep).
- AbstractRegion(BSPTree<S>, double) - Constructor for class org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a region from an inside/outside BSP tree.
- AbstractRegion(Hyperplane<S>[], double) - Constructor for class org.hipparchus.geometry.partitioning.AbstractRegion
-
Build a convex region from an array of bounding hyperplanes.
- AbstractSimplex - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
This class implements the simplex concept.
- AbstractSimplex(double[]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
The start configuration for simplex is built from a box parallel to
the canonical axes of the space.
- AbstractSimplex(double[][]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
The real initial simplex will be set up by moving the reference
simplex such that its first point is located at the start point of the
optimization.
- AbstractSimplex(int) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Build a unit hypercube simplex.
- AbstractSimplex(int, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Build a hypercube simplex with the given side length.
- AbstractStorelessUnivariateStatistic - Class in org.hipparchus.stat.descriptive
-
- AbstractStorelessUnivariateStatistic() - Constructor for class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
- AbstractSubHyperplane<S extends Space,T extends Space> - Class in org.hipparchus.geometry.partitioning
-
This class implements the dimension-independent parts of
SubHyperplane
.
- AbstractSubHyperplane(Hyperplane<S>, Region<T>) - Constructor for class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Build a sub-hyperplane from an hyperplane and a region.
- AbstractUnivariateDifferentiableSolver - Class in org.hipparchus.analysis.solvers
-
Provide a default implementation for several functions useful to generic
solvers.
- AbstractUnivariateDifferentiableSolver(double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateDifferentiableSolver
-
Construct a solver with given absolute accuracy.
- AbstractUnivariateDifferentiableSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateDifferentiableSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateSolver - Class in org.hipparchus.analysis.solvers
-
Base class for solvers.
- AbstractUnivariateSolver(double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given absolute accuracy.
- AbstractUnivariateSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.AbstractUnivariateSolver
-
Construct a solver with given accuracies.
- AbstractUnivariateStatistic - Class in org.hipparchus.stat.descriptive
-
- AbstractUnivariateStatistic() - Constructor for class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Default constructor.
- AbstractUnivariateStatistic(AbstractUnivariateStatistic) - Constructor for class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Copy constructor, creates an identical copy
of the original
.
- AbstractWell - Class in org.hipparchus.random
-
This abstract class implements the WELL class of pseudo-random number generator
from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
- AbstractWell(int) - Constructor for class org.hipparchus.random.AbstractWell
-
Creates a new random number generator.
- AbstractWell(int, int) - Constructor for class org.hipparchus.random.AbstractWell
-
Creates a new random number generator using a single int seed.
- AbstractWell(int, int[]) - Constructor for class org.hipparchus.random.AbstractWell
-
Creates a new random number generator using an int array seed.
- AbstractWell(int, long) - Constructor for class org.hipparchus.random.AbstractWell
-
Creates a new random number generator using a single long seed.
- AbstractWell.IndexTable - Class in org.hipparchus.random
-
Inner class used to store the indirection index table which is fixed
for a given type of WELL class of pseudo-random number generator.
- accept(double) - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
- accept(double) - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
- accept(double) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
- acceptStep(AbstractFieldODEStateInterpolator<T>, T) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Accept a step, triggering events and step handlers.
- acceptStep(AbstractODEStateInterpolator, double) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Accept a step, triggering events and step handlers.
- acos() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.complex.Complex
-
- acos() - Method in class org.hipparchus.dfp.Dfp
-
Arc cosine operation.
- acos() - Method in interface org.hipparchus.RealFieldElement
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.util.Decimal64
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.util.FieldTuple
-
Arc cosine operation.
- acos() - Method in class org.hipparchus.util.Tuple
-
Arc cosine operation.
- acos(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the arc cosine of a number.
- acos(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc cosine of a derivative structure.
- acos(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the arc-cosine of the argument.
- acos(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the arc cosine of a number.
- acos(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc cosine of a derivative structure.
- Acos - Class in org.hipparchus.analysis.function
-
Arc-cosine function.
- Acos() - Constructor for class org.hipparchus.analysis.function.Acos
-
- acosh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.dfp.Dfp
-
Inverse hyperbolic cosine operation.
- acosh() - Method in interface org.hipparchus.RealFieldElement
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.util.Decimal64
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.util.FieldTuple
-
Inverse hyperbolic cosine operation.
- acosh() - Method in class org.hipparchus.util.Tuple
-
Inverse hyperbolic cosine operation.
- acosh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic cosine of a number.
- acosh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic cosine of a derivative structure.
- acosh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic cosine of a number.
- acosh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic cosine of a derivative structure.
- Acosh - Class in org.hipparchus.analysis.function
-
Hyperbolic arc-cosine function.
- Acosh() - Constructor for class org.hipparchus.analysis.function.Acosh
-
- Action - Enum in org.hipparchus.ode.events
-
Enumerate for actions to be performed when an event occurs during ODE integration.
- AdamsBashforthFieldIntegrator<T extends RealFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements explicit Adams-Bashforth integrators for Ordinary
Differential Equations.
- AdamsBashforthFieldIntegrator(Field<T>, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Build an Adams-Bashforth integrator with the given order and step control parameters.
- AdamsBashforthFieldIntegrator(Field<T>, int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Build an Adams-Bashforth integrator with the given order and step control parameters.
- AdamsBashforthIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements explicit Adams-Bashforth integrators for Ordinary
Differential Equations.
- AdamsBashforthIntegrator(int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Build an Adams-Bashforth integrator with the given order and step control parameters.
- AdamsBashforthIntegrator(int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Build an Adams-Bashforth integrator with the given order and step control parameters.
- AdamsFieldIntegrator<T extends RealFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
- AdamsFieldIntegrator(Field<T>, String, int, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsFieldIntegrator(Field<T>, String, int, int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsIntegrator - Class in org.hipparchus.ode.nonstiff
-
- AdamsIntegrator(String, int, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsIntegrator(String, int, int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Build an Adams integrator with the given order and step control parameters.
- AdamsMoultonFieldIntegrator<T extends RealFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements implicit Adams-Moulton integrators for Ordinary
Differential Equations.
- AdamsMoultonFieldIntegrator(Field<T>, int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Build an Adams-Moulton integrator with the given order and error control parameters.
- AdamsMoultonFieldIntegrator(Field<T>, int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Build an Adams-Moulton integrator with the given order and error control parameters.
- AdamsMoultonIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements implicit Adams-Moulton integrators for Ordinary
Differential Equations.
- AdamsMoultonIntegrator(int, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Build an Adams-Moulton integrator with the given order and error control parameters.
- AdamsMoultonIntegrator(int, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Build an Adams-Moulton integrator with the given order and error control parameters.
- AdamsNordsieckFieldTransformer<T extends RealFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
Transformer to Nordsieck vectors for Adams integrators.
- AdamsNordsieckTransformer - Class in org.hipparchus.ode.nonstiff
-
Transformer to Nordsieck vectors for Adams integrators.
- AdaptiveStepsizeFieldIntegrator<T extends RealFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This abstract class holds the common part of all adaptive
stepsize integrators for Ordinary Differential Equations.
- AdaptiveStepsizeFieldIntegrator(Field<T>, String, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Build an integrator with the given stepsize bounds.
- AdaptiveStepsizeFieldIntegrator(Field<T>, String, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Build an integrator with the given stepsize bounds.
- AdaptiveStepsizeIntegrator - Class in org.hipparchus.ode.nonstiff
-
This abstract class holds the common part of all adaptive
stepsize integrators for Ordinary Differential Equations.
- AdaptiveStepsizeIntegrator(String, double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Build an integrator with the given stepsize bounds.
- AdaptiveStepsizeIntegrator(String, double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Build an integrator with the given stepsize bounds.
- add(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'+' operator.
- add(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
'+' operator.
- add(double) - Method in class org.hipparchus.complex.Complex
-
Returns a Complex
whose value is (this + addend)
,
with addend
interpreted as a real number.
- add(double) - Method in class org.hipparchus.dfp.Dfp
-
'+' operator.
- add(double) - Method in interface org.hipparchus.RealFieldElement
-
'+' operator.
- add(double) - Method in class org.hipparchus.util.Decimal64
-
'+' operator.
- add(double) - Method in class org.hipparchus.util.FieldTuple
-
'+' operator.
- add(double) - Method in class org.hipparchus.util.Tuple
-
'+' operator.
- add(double[], boolean) - Method in class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Replace i
-th facet of the microsphere.
- add(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform addition of two derivative structures.
- add(double, double) - Method in class org.hipparchus.fitting.WeightedObservedPoints
-
Adds a point to the sample.
- add(double, double, double) - Method in class org.hipparchus.fitting.WeightedObservedPoints
-
Adds a point to the sample.
- add(double, FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a scaled vector to the instance.
- add(double, Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a scaled vector to the instance.
- add(double, Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Add a scaled vector to the instance.
- add(double, Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Add a scaled vector to the instance.
- add(double, Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Add a scaled vector to the instance.
- add(double, Vector<S>) - Method in interface org.hipparchus.geometry.Vector
-
Add a scaled vector to the instance.
- add(int) - Method in class org.hipparchus.fraction.BigFraction
-
Adds the value of this fraction to the passed integer
, returning
the result in reduced form.
- add(int) - Method in class org.hipparchus.fraction.Fraction
-
Add an integer to the fraction.
- add(long) - Method in class org.hipparchus.fraction.BigFraction
-
Adds the value of this fraction to the passed long
, returning
the result in reduced form.
- add(BigInteger) - Method in class org.hipparchus.fraction.BigFraction
-
Adds the value of this fraction to the passed
BigInteger
,
returning the result in reduced form.
- add(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute this + a.
- add(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute this + a.
- add(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute this + a.
- add(UnivariateDifferentiableFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Adds functions.
- add(PolynomialFunction) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Add a polynomial to the instance.
- add(UnivariateFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Adds functions.
- add(Complex) - Method in class org.hipparchus.complex.Complex
-
Returns a Complex
whose value is
(this + addend)
.
- add(Quaternion) - Method in class org.hipparchus.complex.Quaternion
-
Computes the sum of the instance and another quaternion.
- add(Quaternion, Quaternion) - Static method in class org.hipparchus.complex.Quaternion
-
Computes the sum of two quaternions.
- add(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Add x to this.
- add(WeightedObservedPoint) - Method in class org.hipparchus.fitting.WeightedObservedPoints
-
Adds a point to the sample.
- add(BigFraction) - Method in class org.hipparchus.fraction.BigFraction
-
Adds the value of this fraction to another, returning the result in
reduced form.
- add(Fraction) - Method in class org.hipparchus.fraction.Fraction
-
Adds the value of this fraction to another, returning the result in reduced form.
- add(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a vector to the instance.
- add(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a vector to the instance.
- add(BSPTree<S>) - Method in class org.hipparchus.geometry.partitioning.NodesSet
-
Add a node if not already known.
- add(Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Add a vector to the instance.
- add(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Add a vector to the instance.
- add(Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Add a vector to the instance.
- add(Vector<S>) - Method in interface org.hipparchus.geometry.Vector
-
Add a vector to the instance.
- add(Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Add m
to this matrix.
- add(Array2DRowRealMatrix) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Compute the sum of this
and m
.
- add(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the sum of this
and v
.
- add(BlockFieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Compute the sum of this
and m
.
- add(BlockRealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Compute the sum of this matrix and m
.
- add(DiagonalMatrix) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Compute the sum of this
and m
.
- add(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Compute the sum of this and m.
- add(FieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Compute the sum of this and m.
- add(FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Compute the sum of this and m.
- add(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute the sum of this
and v
.
- add(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Compute the sum of this
and v
.
- add(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Compute the sum of this
and v
.
- add(OpenMapRealMatrix) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Compute the sum of this matrix and m
.
- add(OpenMapRealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Optimized method to add two OpenMapRealVectors.
- add(RealMatrix) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the sum of this
and m
.
- add(RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the sum of this
and m
.
- add(RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the sum of this
and m
.
- add(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Compute the sum of this vector and v
.
- add(RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Compute the sum of this vector and v
.
- add(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Compute the sum of this vector and v
.
- add(SparseFieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Optimized method to add sparse vectors.
- add(BigReal) - Method in class org.hipparchus.util.BigReal
-
Compute this + a.
- add(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
Compute this + a.
- add(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute this + a.
- add(Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute this + a.
- add(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'+' operator.
- add(T) - Method in interface org.hipparchus.FieldElement
-
Compute this + a.
- add(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform addition of two derivative structures.
- add(T, FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a scaled vector to the instance.
- add(T, Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Add a scaled vector to the instance.
- Add - Class in org.hipparchus.analysis.function
-
Add the two operands.
- Add() - Constructor for class org.hipparchus.analysis.function.Add
-
- addAll(Iterable<BSPTree<S>>) - Method in class org.hipparchus.geometry.partitioning.NodesSet
-
Add nodes if they are not already known.
- addAndCheck(int, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Add two integers, checking for overflow.
- addAndCheck(long, long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Add two long integers, checking for overflow.
- addCDFSeries(Chart, IntegerDistribution, String, int, int) - Static method in class org.hipparchus.samples.IntegerDistributionComparison
-
- addCDFSeries(Chart, RealDistribution, String, int, int) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
- addData(double[][]) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Adds the observations represented by the elements in
data
.
- addData(double, double) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Adds the observation (x,y) to the regression data set.
- addElement(double) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Adds an element to the end of this expandable array.
- addElementRolling(double) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Adds an element to the end of the array and removes the first
element in the array.
- addElements(double[]) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Adds several element to the end of this expandable array.
- addEventHandler(FieldODEEventHandler<T>, double, double, int) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Add an event handler to the integrator.
- addEventHandler(FieldODEEventHandler<T>, double, double, int) - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Add an event handler to the integrator.
- addEventHandler(FieldODEEventHandler<T>, double, double, int, BracketedRealFieldUnivariateSolver<T>) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Add an event handler to the integrator.
- addEventHandler(FieldODEEventHandler<T>, double, double, int, BracketedRealFieldUnivariateSolver<T>) - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Add an event handler to the integrator.
- addEventHandler(ODEEventHandler, double, double, int) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Add an event handler to the integrator.
- addEventHandler(ODEEventHandler, double, double, int) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Add an event handler to the integrator.
- addEventHandler(ODEEventHandler, double, double, int, BracketedUnivariateSolver<UnivariateFunction>) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Add an event handler to the integrator.
- addEventHandler(ODEEventHandler, double, double, int, BracketedUnivariateSolver<UnivariateFunction>) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Add an event handler to the integrator.
- addExact(int, int) - Static method in class org.hipparchus.util.FastMath
-
Add two numbers, detecting overflows.
- addExact(long, long) - Static method in class org.hipparchus.util.FastMath
-
Add two numbers, detecting overflows.
- addInPlace(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Add in place.
- addIterationListener(IterationListener) - Method in class org.hipparchus.util.IterationManager
-
Attaches a listener to this manager.
- ADDITIVE - org.hipparchus.util.ResizableDoubleArray.ExpansionMode
-
Additive expansion mode.
- addObservation(double[], double) - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Adds an observation to the regression model.
- addObservation(double[], double) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Adds one observation to the regression model.
- addObservation(double[], double) - Method in interface org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Adds one observation to the regression model.
- addObservations(double[][], double[]) - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Adds multiple observations to the model.
- addObservations(double[][], double[]) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Adds a series of observations to the regression model.
- addObservations(double[][], double[]) - Method in interface org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Adds a series of observations to the regression model.
- addParameterJacobianProvider(NamedParameterJacobianProvider) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.
Add a parameter Jacobian provider.
- addPDFSeries(Chart, IntegerDistribution, String, int, int) - Static method in class org.hipparchus.samples.IntegerDistributionComparison
-
- addPDFSeries(Chart, RealDistribution, String, int, int) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
- addPoint(T) - Method in class org.hipparchus.clustering.Cluster
-
Add a point to this cluster.
- addRule(Pair<T[], T[]>) - Method in class org.hipparchus.analysis.integration.gauss.BaseRuleFactory
-
Stores a rule.
- addSamplePoint(double, double[]...) - Method in class org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Add a sample point.
- addSamplePoint(T, T[]...) - Method in class org.hipparchus.analysis.interpolation.FieldHermiteInterpolator
-
Add a sample point.
- addSecondaryEquations(FieldSecondaryODE<T>) - Method in class org.hipparchus.ode.FieldExpandableODE
-
Add a set of secondary equations to be integrated along with the primary set.
- addSecondaryEquations(SecondaryODE) - Method in class org.hipparchus.ode.ExpandableODE
-
Add a set of secondary equations to be integrated along with the primary set.
- addStepHandler(FieldODEStepHandler<T>) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Add a step handler to this integrator.
- addStepHandler(FieldODEStepHandler<T>) - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Add a step handler to this integrator.
- addStepHandler(ODEStepHandler) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Add a step handler to this integrator.
- addStepHandler(ODEStepHandler) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Add a step handler to this integrator.
- addToEntry(int, double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Change an entry at the specified index.
- addToEntry(int, double) - Method in class org.hipparchus.linear.RealVector
-
Change an entry at the specified index.
- addToEntry(int, int, double) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix.
- addToEntry(int, int, double) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix.
- addToEntry(int, int, double) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix.
- addToEntry(int, int, double) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix.
- addToEntry(int, int, double) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix.
- addToEntry(int, int, double) - Method in interface org.hipparchus.linear.RealMatrix
-
Adds (in place) the specified value to the specified entry of
this
matrix.
- addToEntry(int, int, T) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - Method in interface org.hipparchus.linear.FieldMatrix
-
Change an entry in the specified row and column.
- addToEntry(int, int, T) - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Change an entry in the specified row and column.
- addValue(double) - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Adds the value to the dataset.
- addValue(double) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Add a value to the data
- addValue(double[]) - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Add an n-tuple to the data
- addValue(int) - Method in class org.hipparchus.stat.LongFrequency
-
Adds 1 to the frequency count for v.
- addValue(T) - Method in class org.hipparchus.stat.Frequency
-
Adds 1 to the frequency count for v.
- advance() - Method in class org.hipparchus.util.OpenIntToDoubleHashMap.Iterator
-
Advance iterator one step further.
- advance() - Method in class org.hipparchus.util.OpenIntToFieldHashMap.Iterator
-
Advance iterator one step further.
- advance(RealVector.Entry) - Method in class org.hipparchus.linear.RealVector.SparseEntryIterator
-
Advance an entry up to the next nonzero one.
- AggregatableStatistic<T> - Interface in org.hipparchus.stat.descriptive
-
An interface for statistics that can aggregate results.
- aggregate(Iterable<? extends StatisticalSummary>) - Static method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
Computes aggregated statistical summaries.
- aggregate(Iterable<T>) - Method in interface org.hipparchus.stat.descriptive.AggregatableStatistic
-
Aggregates the results from the provided instances into this instance.
- aggregate(GeometricMean) - Method in class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Aggregates the provided instance into this instance.
- aggregate(Mean) - Method in class org.hipparchus.stat.descriptive.moment.Mean
-
Aggregates the provided instance into this instance.
- aggregate(SecondMoment) - Method in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Aggregates the provided instance into this instance.
- aggregate(Variance) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Aggregates the provided instance into this instance.
- aggregate(Max) - Method in class org.hipparchus.stat.descriptive.rank.Max
-
Aggregates the provided instance into this instance.
- aggregate(Min) - Method in class org.hipparchus.stat.descriptive.rank.Min
-
Aggregates the provided instance into this instance.
- aggregate(RandomPercentile) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Aggregates the provided instance into this instance.
- aggregate(StatisticalSummary...) - Static method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
Computes aggregated statistical summaries.
- aggregate(StreamingStatistics) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Aggregates the provided instance into this instance.
- aggregate(Product) - Method in class org.hipparchus.stat.descriptive.summary.Product
-
Aggregates the provided instance into this instance.
- aggregate(Sum) - Method in class org.hipparchus.stat.descriptive.summary.Sum
-
Aggregates the provided instance into this instance.
- aggregate(SumOfLogs) - Method in class org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Aggregates the provided instance into this instance.
- aggregate(SumOfSquares) - Method in class org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Aggregates the provided instance into this instance.
- aggregate(T) - Method in interface org.hipparchus.stat.descriptive.AggregatableStatistic
-
Aggregates the provided instance into this instance.
- aggregate(T...) - Method in interface org.hipparchus.stat.descriptive.AggregatableStatistic
-
Aggregates the results from the provided instances into this instance.
- AkimaSplineInterpolator - Class in org.hipparchus.analysis.interpolation
-
Computes a cubic spline interpolation for the data set using the Akima
algorithm, as originally formulated by Hiroshi Akima in his 1970 paper
"A New Method of Interpolation and Smooth Curve Fitting Based on Local Procedures."
J.
- AkimaSplineInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.AkimaSplineInterpolator
-
- AklToussaintHeuristic - Class in org.hipparchus.geometry.euclidean.twod.hull
-
A simple heuristic to improve the performance of convex hull algorithms.
- align(int) - Method in class org.hipparchus.dfp.Dfp
-
Make our exp equal to the supplied one, this may cause rounding.
- AllowedSolution - Enum in org.hipparchus.analysis.solvers
-
- AlternativeHypothesis - Enum in org.hipparchus.stat.inference
-
Represents an alternative hypothesis for a hypothesis test.
- angle(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the angular separation between two vectors.
- angle(FieldVector3D<T>, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the angular separation between two vectors.
- angle(Vector3D, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the angular separation between two vectors.
- angle(Vector3D, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the angular separation between two vectors.
- angle(Vector2D, Vector2D) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the angular separation between two vectors.
- anovaFValue(Collection<double[]>) - Method in class org.hipparchus.stat.inference.OneWayAnova
-
Computes the ANOVA F-value for a collection of double[]
arrays.
- anovaPValue(Collection<double[]>) - Method in class org.hipparchus.stat.inference.OneWayAnova
-
Computes the ANOVA P-value for a collection of double[]
arrays.
- anovaPValue(Collection<StreamingStatistics>, boolean) - Method in class org.hipparchus.stat.inference.OneWayAnova
-
- anovaTest(Collection<double[]>, double) - Method in class org.hipparchus.stat.inference.OneWayAnova
-
Performs an ANOVA test, evaluating the null hypothesis that there
is no difference among the means of the data categories.
- antiDerivative() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns an anti-derivative of this polynomial, with 0 constant term.
- ANY_SIDE - org.hipparchus.analysis.solvers.AllowedSolution
-
There are no additional side restriction on the solutions for
root-finding.
- AnyMatrix - Interface in org.hipparchus.linear
-
Interface defining very basic matrix operations.
- append(double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Construct a new vector by appending a double to this vector.
- append(double) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Construct a new vector by appending a double to this vector.
- append(double) - Method in class org.hipparchus.linear.RealVector
-
Construct a new vector by appending a double to this vector.
- append(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending a vector to this vector.
- append(ArrayRealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending a vector to this vector.
- append(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending a vector to this vector.
- append(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Construct a vector by appending a vector to this vector.
- append(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Construct a vector by appending a vector to this vector.
- append(OpenMapRealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Optimized method to append a OpenMapRealVector.
- append(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Construct a new vector by appending a vector to this vector.
- append(RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Construct a new vector by appending a vector to this vector.
- append(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Construct a new vector by appending a vector to this vector.
- append(SparseFieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Construct a vector by appending a vector to this vector.
- append(DenseOutputModel) - Method in class org.hipparchus.ode.DenseOutputModel
-
Append another model at the end of the instance.
- append(FieldDenseOutputModel<T>) - Method in class org.hipparchus.ode.FieldDenseOutputModel
-
Append another model at the end of the instance.
- append(StorelessCovariance) - Method in class org.hipparchus.stat.correlation.StorelessCovariance
-
Appends sc
to this, effectively aggregating the computations in sc
with this.
- append(SimpleRegression) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Appends data from another regression calculation to this one.
- append(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending a T to this vector.
- append(T) - Method in interface org.hipparchus.linear.FieldVector
-
Construct a vector by appending a T to this vector.
- append(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Construct a vector by appending a T to this vector.
- apply(Hyperplane<S>) - Method in interface org.hipparchus.geometry.partitioning.Transform
-
Transform an hyperplane of a space.
- apply(SubHyperplane<T>, Hyperplane<S>, Hyperplane<S>) - Method in interface org.hipparchus.geometry.partitioning.Transform
-
Transform a sub-hyperplane embedded in an hyperplane.
- apply(Point<S>) - Method in interface org.hipparchus.geometry.partitioning.Transform
-
Transform a point of a space.
- apply(UnivariateStatistic) - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Apply the given statistic to the data associated with this set of statistics.
- applyInverseTo(double[], double[]) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the inverse of the rotation to a vector stored in an array.
- applyInverseTo(double[], T[]) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the rotation to a vector stored in an array.
- applyInverseTo(FieldRotation<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the instance to another rotation.
- applyInverseTo(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the rotation to a vector.
- applyInverseTo(Rotation) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the instance to another rotation.
- applyInverseTo(Rotation) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the inverse of the instance to another rotation.
- applyInverseTo(Rotation, FieldRotation<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of a rotation to another rotation.
- applyInverseTo(Rotation, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of a rotation to a vector.
- applyInverseTo(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the rotation to a vector.
- applyInverseTo(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the inverse of the rotation to a vector.
- applyInverseTo(T[], T[]) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the inverse of the rotation to a vector stored in an array.
- applyTo(double[], double[]) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the rotation to a vector stored in an array.
- applyTo(double[], T[]) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the rotation to a vector stored in an array.
- applyTo(FieldRotation<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the instance to another rotation.
- applyTo(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the rotation to a vector.
- applyTo(Rotation) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the instance to another rotation.
- applyTo(Rotation) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the instance to another rotation.
- applyTo(Rotation, FieldRotation<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply a rotation to another rotation.
- applyTo(Rotation, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply a rotation to a vector.
- applyTo(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the rotation to a vector.
- applyTo(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Apply the rotation to a vector.
- applyTo(T[], T[]) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Apply the rotation to a vector stored in an array.
- applyTransform(Transform<S, T>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Transform a region.
- applyTransform(Transform<S, T>) - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Apply a transform to the instance.
- approximateP(double, int, int) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- approximateP(double, int, int) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Uses the Kolmogorov-Smirnov distribution to approximate \(P(D_{n,m} > d)\) where \(D_{n,m}\)
is the 2-sample Kolmogorov-Smirnov statistic.
- Arc - Class in org.hipparchus.geometry.spherical.oned
-
This class represents an arc on a circle.
- Arc(double, double, double) - Constructor for class org.hipparchus.geometry.spherical.oned.Arc
-
Simple constructor.
- ArcsSet - Class in org.hipparchus.geometry.spherical.oned
-
This class represents a region of a circle: a set of arcs.
- ArcsSet(double) - Constructor for class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an arcs set representing the whole circle.
- ArcsSet(double, double, double) - Constructor for class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an arcs set corresponding to a single arc.
- ArcsSet(Collection<SubHyperplane<Sphere1D>>, double) - Constructor for class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an arcs set from a Boundary REPresentation (B-rep).
- ArcsSet(BSPTree<Sphere1D>, double) - Constructor for class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an arcs set from an inside/outside BSP tree.
- ArcsSet.InconsistentStateAt2PiWrapping - Exception in org.hipparchus.geometry.spherical.oned
-
Specialized exception for inconsistent BSP tree state inconsistency.
- ArcsSet.Split - Class in org.hipparchus.geometry.spherical.oned
-
Class holding the results of the
split
method.
- ARGUMENT_OUTSIDE_DOMAIN - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ARGUMENT_OUTSIDE_DOMAIN - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- ARITHMETIC_EXCEPTION - org.hipparchus.exception.LocalizedCoreFormats
-
- ARITHMETIC_EXCEPTION - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ArithmeticUtils - Class in org.hipparchus.util
-
Some useful, arithmetics related, additions to the built-in functions in
Math
.
- ARRAY_ELEMENT - org.hipparchus.exception.LocalizedCoreFormats
-
- ARRAY_ELEMENT - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ARRAY_SIZE_EXCEEDS_MAX_VARIABLES - org.hipparchus.exception.LocalizedCoreFormats
-
- ARRAY_SIZE_EXCEEDS_MAX_VARIABLES - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1 - org.hipparchus.exception.LocalizedCoreFormats
-
- ARRAY_SIZES_SHOULD_HAVE_DIFFERENCE_1 - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ARRAY_SUMS_TO_ZERO - org.hipparchus.exception.LocalizedCoreFormats
-
- ARRAY_SUMS_TO_ZERO - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED - org.hipparchus.exception.LocalizedCoreFormats
-
- ARRAY_ZERO_LENGTH_OR_NULL_NOT_ALLOWED - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- Array2DRowFieldMatrix<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Implementation of FieldMatrix
using a FieldElement
[][] array to store entries.
- Array2DRowFieldMatrix(Field<T>) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Creates a matrix with no data
- Array2DRowFieldMatrix(Field<T>, int, int) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
with the supplied row and column dimensions.
- Array2DRowFieldMatrix(Field<T>, T[]) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new (column) FieldMatrix<T>
using v
as the
data for the unique column of the created matrix.
- Array2DRowFieldMatrix(Field<T>, T[][]) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
using the input array as the underlying
data array.
- Array2DRowFieldMatrix(Field<T>, T[][], boolean) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
using the input array as the underlying
data array.
- Array2DRowFieldMatrix(T[]) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new (column) FieldMatrix<T>
using v
as the
data for the unique column of the created matrix.
- Array2DRowFieldMatrix(T[][]) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
using the input array as the underlying
data array.
- Array2DRowFieldMatrix(T[][], boolean) - Constructor for class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix<T>
using the input array as the underlying
data array.
- Array2DRowRealMatrix - Class in org.hipparchus.linear
-
Implementation of
RealMatrix
using a
double[][]
array to
store entries.
- Array2DRowRealMatrix() - Constructor for class org.hipparchus.linear.Array2DRowRealMatrix
-
Creates a matrix with no data
- Array2DRowRealMatrix(double[]) - Constructor for class org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new (column) RealMatrix using v
as the
data for the unique column of the created matrix.
- Array2DRowRealMatrix(double[][]) - Constructor for class org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new RealMatrix
using the input array as the underlying
data array.
- Array2DRowRealMatrix(double[][], boolean) - Constructor for class org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new RealMatrix using the input array as the underlying
data array.
- Array2DRowRealMatrix(int, int) - Constructor for class org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new RealMatrix with the supplied row and column dimensions.
- ArrayFieldVector<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
- ArrayFieldVector(int, T) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector with preset values.
- ArrayFieldVector(Field<T>) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Build a 0-length vector.
- ArrayFieldVector(Field<T>, int) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector of zeroes.
- ArrayFieldVector(Field<T>, T[]) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from an array, copying the input array.
- ArrayFieldVector(Field<T>, T[], boolean) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Create a new ArrayFieldVector using the input array as the underlying
data array.
- ArrayFieldVector(Field<T>, T[], int, int) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from part of a array.
- ArrayFieldVector(Field<T>, T[], T[]) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(ArrayFieldVector<T>) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from another vector, using a deep copy.
- ArrayFieldVector(ArrayFieldVector<T>, boolean) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from another vector.
- ArrayFieldVector(FieldVector<T>) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from another vector, using a deep copy.
- ArrayFieldVector(FieldVector<T>, FieldVector<T>) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(FieldVector<T>, T[]) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(T[]) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from an array, copying the input array.
- ArrayFieldVector(T[], boolean) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Create a new ArrayFieldVector using the input array as the underlying
data array.
- ArrayFieldVector(T[], int, int) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector from part of a array.
- ArrayFieldVector(T[], FieldVector<T>) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayFieldVector(T[], T[]) - Constructor for class org.hipparchus.linear.ArrayFieldVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector - Class in org.hipparchus.linear
-
This class implements the
RealVector
interface with a double array.
- ArrayRealVector() - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Build a 0-length vector.
- ArrayRealVector(double[]) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector from an array, copying the input array.
- ArrayRealVector(double[], boolean) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Create a new ArrayRealVector using the input array as the underlying
data array.
- ArrayRealVector(double[], double[]) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(double[], int, int) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector from part of a array.
- ArrayRealVector(double[], ArrayRealVector) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(int) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector of zeroes.
- ArrayRealVector(int, double) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector with preset values.
- ArrayRealVector(Double[]) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector from an array.
- ArrayRealVector(Double[], int, int) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector from part of an array.
- ArrayRealVector(ArrayRealVector) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector from another vector, using a deep copy.
- ArrayRealVector(ArrayRealVector, boolean) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector from another vector.
- ArrayRealVector(ArrayRealVector, double[]) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(ArrayRealVector, ArrayRealVector) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(ArrayRealVector, RealVector) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- ArrayRealVector(RealVector) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector from another vector, using a deep copy.
- ArrayRealVector(RealVector, ArrayRealVector) - Constructor for class org.hipparchus.linear.ArrayRealVector
-
Construct a vector by appending one vector to another vector.
- asin() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc sine operation.
- asin() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Arc sine operation.
- asin() - Method in class org.hipparchus.complex.Complex
-
- asin() - Method in class org.hipparchus.dfp.Dfp
-
Arc sine operation.
- asin() - Method in interface org.hipparchus.RealFieldElement
-
Arc sine operation.
- asin() - Method in class org.hipparchus.util.Decimal64
-
Arc sine operation.
- asin() - Method in class org.hipparchus.util.FieldTuple
-
Arc sine operation.
- asin() - Method in class org.hipparchus.util.Tuple
-
Arc sine operation.
- asin(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the arc sine of a number.
- asin(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc sine of a derivative structure.
- asin(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the arc-sine of the argument.
- asin(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the arc sine of a number.
- asin(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc sine of a derivative structure.
- Asin - Class in org.hipparchus.analysis.function
-
Arc-sine function.
- Asin() - Constructor for class org.hipparchus.analysis.function.Asin
-
- asinh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.dfp.Dfp
-
Inverse hyperbolic sine operation.
- asinh() - Method in interface org.hipparchus.RealFieldElement
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.util.Decimal64
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.util.FieldTuple
-
Inverse hyperbolic sine operation.
- asinh() - Method in class org.hipparchus.util.Tuple
-
Inverse hyperbolic sine operation.
- asinh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic sine of a number.
- asinh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic sine of a derivative structure.
- asinh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic sine of a number.
- asinh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic sine of a derivative structure.
- Asinh - Class in org.hipparchus.analysis.function
-
Hyperbolic arc-sine function.
- Asinh() - Constructor for class org.hipparchus.analysis.function.Asinh
-
- asList() - Method in class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Build an ordered list of intervals representing the instance.
- asList() - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Build an ordered list of arcs representing the instance.
- ASSYMETRIC_EIGEN_NOT_SUPPORTED - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ASSYMETRIC_EIGEN_NOT_SUPPORTED - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- AT_LEAST_ONE_COLUMN - org.hipparchus.exception.LocalizedCoreFormats
-
- AT_LEAST_ONE_COLUMN - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- AT_LEAST_ONE_ROW - org.hipparchus.exception.LocalizedCoreFormats
-
- AT_LEAST_ONE_ROW - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- atan() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.complex.Complex
-
- atan() - Method in class org.hipparchus.dfp.Dfp
-
Arc tangent operation.
- atan() - Method in interface org.hipparchus.RealFieldElement
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.util.Decimal64
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.util.FieldTuple
-
Arc tangent operation.
- atan() - Method in class org.hipparchus.util.Tuple
-
Arc tangent operation.
- atan(double) - Static method in class org.hipparchus.util.FastMath
-
Arctangent function
- atan(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc tangent of a derivative structure.
- atan(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the arc tangent of the argument
Uses the typical taylor series
but may reduce arguments using the following identity
tan(x+y) = (tan(x) + tan(y)) / (1 - tan(x)*tan(y))
since tan(PI/8) = sqrt(2)-1,
atan(x) = atan( (x - sqrt(2) + 1) / (1+x*sqrt(2) - x) + PI/8.0
- atan(T) - Static method in class org.hipparchus.util.FastMath
-
Arctangent function
- atan(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute arc tangent of a derivative structure.
- Atan - Class in org.hipparchus.analysis.function
-
Arc-tangent function.
- Atan() - Constructor for class org.hipparchus.analysis.function.Atan
-
- atan2(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute two arguments arc tangent of a derivative structure.
- atan2(double, double) - Static method in class org.hipparchus.util.FastMath
-
Two arguments arctangent function
- atan2(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Two arguments arc tangent operation.
- atan2(DerivativeStructure, DerivativeStructure) - Static method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Two arguments arc tangent operation.
- atan2(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Two arguments arc tangent operation.
- atan2(FieldDerivativeStructure<T>, FieldDerivativeStructure<T>) - Static method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Two arguments arc tangent operation.
- atan2(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Two arguments arc tangent operation.
- atan2(SparseGradient, SparseGradient) - Static method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Two arguments arc tangent operation.
- atan2(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Two arguments arc tangent operation.
- atan2(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
Two arguments arc tangent operation.
- atan2(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Two arguments arc tangent operation.
- atan2(Tuple) - Method in class org.hipparchus.util.Tuple
-
Two arguments arc tangent operation.
- atan2(T) - Method in interface org.hipparchus.RealFieldElement
-
Two arguments arc tangent operation.
- atan2(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute two arguments arc tangent of a derivative structure.
- atan2(T, T) - Static method in class org.hipparchus.util.FastMath
-
Two arguments arctangent function
- Atan2 - Class in org.hipparchus.analysis.function
-
Arc-tangent function.
- Atan2() - Constructor for class org.hipparchus.analysis.function.Atan2
-
- atanh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.dfp.Dfp
-
Inverse hyperbolic tangent operation.
- atanh() - Method in interface org.hipparchus.RealFieldElement
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.util.Decimal64
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.util.FieldTuple
-
Inverse hyperbolic tangent operation.
- atanh() - Method in class org.hipparchus.util.Tuple
-
Inverse hyperbolic tangent operation.
- atanh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic tangent of a number.
- atanh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic tangent of a derivative structure.
- atanh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the inverse hyperbolic tangent of a number.
- atanh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute inverse hyperbolic tangent of a derivative structure.
- Atanh - Class in org.hipparchus.analysis.function
-
Hyperbolic arc-tangent function.
- Atanh() - Constructor for class org.hipparchus.analysis.function.Atanh
-
- atanInternal(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the arc-tangent of the argument.
- AVERAGE - org.hipparchus.stat.ranking.TiesStrategy
-
Ties get the average of applicable ranks
- calculateAdjustedRSquared() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Returns the adjusted R-squared statistic, defined by the formula
- calculateBeta() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the beta of multiple linear regression in matrix notation.
- calculateBeta() - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Calculates beta by GLS.
- calculateBeta() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Calculates the regression coefficients using OLS.
- calculateBetaVariance() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the beta variance of multiple linear regression in matrix
notation.
- calculateBetaVariance() - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Calculates the variance on the beta.
- calculateBetaVariance() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Calculates the variance-covariance matrix of the regression parameters.
- calculateErrorVariance() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the variance of the error term.
- calculateErrorVariance() - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Calculates the estimated variance of the error term using the formula
- calculateHat() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Compute the "hat" matrix.
- calculateNumericalMean() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
- calculateNumericalVariance() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
- calculateResiduals() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the residuals of multiple linear regression in matrix
notation.
- calculateResidualSumOfSquares() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Returns the sum of squared residuals.
- calculateRSquared() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Returns the R-Squared statistic, defined by the formula
- calculateTotalSumOfSquares() - Method in class org.hipparchus.stat.regression.OLSMultipleLinearRegression
-
Returns the sum of squared deviations of Y from its mean.
- calculateYVariance() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Calculates the variance of the y values.
- CanberraDistance - Class in org.hipparchus.clustering.distance
-
Calculates the Canberra distance between two points.
- CanberraDistance() - Constructor for class org.hipparchus.clustering.distance.CanberraDistance
-
- canIncrement() - Method in class org.hipparchus.util.Incrementor
-
Checks whether incrementing the counter nTimes
is allowed.
- canIncrement(int) - Method in class org.hipparchus.util.Incrementor
-
Checks whether incrementing the counter several times is allowed.
- CANNOT_CLEAR_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_CLEAR_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- CANNOT_COMPUTE_0TH_ROOT_OF_UNITY - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_COMPUTE_0TH_ROOT_OF_UNITY - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_COMPUTE_BETA_DENSITY_AT_0_FOR_SOME_ALPHA - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_COMPUTE_BETA_DENSITY_AT_0_FOR_SOME_ALPHA - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_COMPUTE_BETA_DENSITY_AT_1_FOR_SOME_BETA - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_COMPUTE_BETA_DENSITY_AT_1_FOR_SOME_BETA - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_COMPUTE_NTH_ROOT_FOR_NEGATIVE_N - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_COMPUTE_NTH_ROOT_FOR_NEGATIVE_N - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_DISCARD_NEGATIVE_NUMBER_OF_ELEMENTS - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_DISCARD_NEGATIVE_NUMBER_OF_ELEMENTS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_FORMAT_INSTANCE_AS_3D_VECTOR - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_FORMAT_INSTANCE_AS_3D_VECTOR - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- CANNOT_FORMAT_INSTANCE_AS_COMPLEX - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_FORMAT_INSTANCE_AS_COMPLEX - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_FORMAT_INSTANCE_AS_REAL_VECTOR - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_FORMAT_INSTANCE_AS_REAL_VECTOR - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- CANNOT_FORMAT_OBJECT_TO_FRACTION - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_FORMAT_OBJECT_TO_FRACTION - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_INCREMENT_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_INCREMENT_STATISTIC_CONSTRUCTED_FROM_EXTERNAL_MOMENTS - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- CANNOT_NORMALIZE_A_ZERO_NORM_VECTOR - org.hipparchus.geometry.LocalizedGeometryFormats
-
- CANNOT_NORMALIZE_A_ZERO_NORM_VECTOR - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_PARSE - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_PARSE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_PARSE_AS_TYPE - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_PARSE_AS_TYPE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_RETRIEVE_AT_NEGATIVE_INDEX - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_RETRIEVE_AT_NEGATIVE_INDEX - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- CANNOT_SET_AT_NEGATIVE_INDEX - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_SET_AT_NEGATIVE_INDEX - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- CANNOT_SUBSTITUTE_ELEMENT_FROM_EMPTY_ARRAY - org.hipparchus.exception.LocalizedCoreFormats
-
- CANNOT_SUBSTITUTE_ELEMENT_FROM_EMPTY_ARRAY - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_TRANSFORM_TO_DOUBLE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CANNOT_TRANSFORM_TO_DOUBLE - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- CARDAN_ANGLES_SINGULARITY - org.hipparchus.geometry.LocalizedGeometryFormats
-
- CARDAN_ANGLES_SINGULARITY - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CardanEulerSingularityException - Exception in org.hipparchus.migration.geometry.euclidean
-
- CardanEulerSingularityException(boolean) - Constructor for exception org.hipparchus.migration.geometry.euclidean.CardanEulerSingularityException
-
Deprecated.
Simple constructor.
- CauchyDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the Cauchy distribution.
- CauchyDistribution() - Constructor for class org.hipparchus.distribution.continuous.CauchyDistribution
-
Creates a Cauchy distribution with the median equal to zero and scale
equal to one.
- CauchyDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.CauchyDistribution
-
Creates a Cauchy distribution.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Cubic root.
- cbrt() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Cubic root.
- cbrt() - Method in class org.hipparchus.dfp.Dfp
-
Cubic root.
- cbrt() - Method in interface org.hipparchus.RealFieldElement
-
Cubic root.
- cbrt() - Method in class org.hipparchus.util.Decimal64
-
Cubic root.
- cbrt() - Method in class org.hipparchus.util.FieldTuple
-
Cubic root.
- cbrt() - Method in class org.hipparchus.util.Tuple
-
Cubic root.
- cbrt(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the cubic root of a number.
- cbrt(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the cubic root of a number.
- Cbrt - Class in org.hipparchus.analysis.function
-
Cube root function.
- Cbrt() - Constructor for class org.hipparchus.analysis.function.Cbrt
-
- cdf(double, int) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Calculates P(D_n < d)
using the method described in [1] with quick decisions for extreme
values given in [2] (see above).
- cdf(double, int, boolean) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Calculates P(D_n < d)
using method described in [1] with quick decisions for extreme
values given in [2] (see above).
- cdfExact(double, int) - Method in class org.hipparchus.stat.inference.KolmogorovSmirnovTest
-
Calculates P(D_n < d)
.
- ceil() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.dfp.Dfp
-
Round to an integer using the round ceil mode.
- ceil() - Method in interface org.hipparchus.RealFieldElement
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.util.Decimal64
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.util.FieldTuple
-
Get the smallest whole number larger than instance.
- ceil() - Method in class org.hipparchus.util.Tuple
-
Get the smallest whole number larger than instance.
- ceil(double) - Static method in class org.hipparchus.util.FastMath
-
Get the smallest whole number larger than x.
- ceil(T) - Static method in class org.hipparchus.util.FastMath
-
Get the smallest whole number larger than x.
- Ceil - Class in org.hipparchus.analysis.function
-
ceil
function.
- Ceil() - Constructor for class org.hipparchus.analysis.function.Ceil
-
- CENTRAL - org.hipparchus.util.PivotingStrategy
-
A mid point strategy based on the average of begin and end indices.
- CentroidCluster<T extends Clusterable> - Class in org.hipparchus.clustering
-
A Cluster used by centroid-based clustering algorithms.
- CentroidCluster(Clusterable) - Constructor for class org.hipparchus.clustering.CentroidCluster
-
Build a cluster centered at a specified point.
- centroidOf(Cluster<T>) - Method in class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
Computes the centroid for a cluster.
- ChebyshevDistance - Class in org.hipparchus.clustering.distance
-
Calculates the L∞ (max of abs) distance between two points.
- ChebyshevDistance() - Constructor for class org.hipparchus.clustering.distance.ChebyshevDistance
-
- checkAdditionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrices are addition compatible.
- checkAdditionCompatible(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if a matrix is addition compatible with the instance.
- checkAndNormalize(double[]) - Static method in class org.hipparchus.distribution.EnumeratedDistribution
-
Checks to make sure that weights is neither null nor empty and contains only non-negative, finite,
non-NaN values and if necessary normalizes it to sum to 1.
- checkBinomial(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Check binomial preconditions.
- checkColumnIndex(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if a column index is valid.
- checkColumnIndex(AnyMatrix, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if a column index is valid.
- checkCompatibility(DSCompiler) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Check rules set compatibility.
- checkContractExpand(double, double) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Checks the expansion factor and the contraction criterion and raises
an exception if the contraction criterion is smaller than the
expansion criterion.
- checkDefinition(RealMatrix) - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Check definition of the decomposition in runtime.
- checkDimension(int, int) - Static method in class org.hipparchus.util.MathUtils
-
Checks that the given dimensions match.
- checkEqualLength(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that both arrays have the same length.
- checkEqualLength(double[], double[], boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that both arrays have the same length.
- checkEqualLength(int[], int[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that both arrays have the same length.
- checkEqualLength(int[], int[], boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that both arrays have the same length.
- checker(ConvergenceChecker<LeastSquaresProblem.Evaluation>) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the convergence checker.
- checkerPair(ConvergenceChecker<PointVectorValuePair>) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the convergence checker.
- checkFinite(double) - Static method in class org.hipparchus.util.MathUtils
-
Check that the argument is a real number.
- checkFinite(double[]) - Static method in class org.hipparchus.util.MathUtils
-
Check that all the elements are real numbers.
- checkIndex(int) - Method in class org.hipparchus.linear.RealVector
-
Check if an index is valid.
- checkIndices(int, int) - Method in class org.hipparchus.linear.RealVector
-
Checks that the indices of a subvector are valid.
- checkMatrixIndex(AnyMatrix, int, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrix indices are valid.
- checkMultiplicationCompatible(AnyMatrix, AnyMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrices are multiplication compatible
- checkMultiplicationCompatible(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if a matrix is multiplication compatible with the instance.
- checkNonNegative(long[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that all entries of the input array are >= 0.
- checkNonNegative(long[][]) - Static method in class org.hipparchus.util.MathArrays
-
Check all entries of the input array are >= 0.
- checkNotNaN(double[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that no entry of the input array is NaN
.
- checkNotNull(Object) - Static method in class org.hipparchus.util.MathUtils
-
Checks that an object is not null.
- checkNotNull(Object, Localizable, Object...) - Static method in class org.hipparchus.util.MathUtils
-
Checks that an object is not null.
- checkOrder(double[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that the given array is sorted in strictly increasing order.
- checkOrder(double[], MathArrays.OrderDirection, boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that the given array is sorted.
- checkOrder(double[], MathArrays.OrderDirection, boolean, boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that the given array is sorted.
- checkParameters(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Static method in class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Performs all dimension checks on the parameters of
solve
and
solveInPlace
,
and throws an exception if one of the checks fails.
- checkParameters(RealLinearOperator, RealVector, RealVector) - Static method in class org.hipparchus.linear.IterativeLinearSolver
-
Performs all dimension checks on the parameters of
solve
and
solveInPlace
,
and throws an exception if one of the checks fails.
- checkPoint(double) - Method in class org.hipparchus.geometry.spherical.oned.Arc
-
Check a point with respect to the arc.
- checkPoint(double, double) - Method in class org.hipparchus.geometry.euclidean.oned.Interval
-
Check a point with respect to the interval.
- checkPoint(BSPTree<S>, Point<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region starting at a given node.
- checkPoint(BSPTree<S>, Vector<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region starting at a given node.
- checkPoint(Point<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region.
- checkPoint(Point<S>) - Method in interface org.hipparchus.geometry.partitioning.Region
-
Check a point with respect to the region.
- checkPoint(Vector<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check a point with respect to the region.
- checkPositive(double[]) - Static method in class org.hipparchus.util.MathArrays
-
Check that all entries of the input array are strictly positive.
- checkRangeInclusive(double, double, double) - Static method in class org.hipparchus.util.MathUtils
-
Checks that the given value is strictly within the range [lo, hi].
- checkRangeInclusive(long, long, long) - Static method in class org.hipparchus.util.MathUtils
-
Checks that the given value is strictly within the range [lo, hi].
- checkRectangular(long[][]) - Static method in class org.hipparchus.util.MathArrays
-
Throws MathIllegalArgumentException if the input array is not rectangular.
- checkRowIndex(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if a row index is valid.
- checkRowIndex(AnyMatrix, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if a row index is valid.
- checkSameColumnDimension(AnyMatrix, AnyMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrices have the same number of columns.
- checkSameRowDimension(AnyMatrix, AnyMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrices have the same number of rows.
- checkSubMatrixIndex(int[], int[]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if submatrix ranges indices are valid.
- checkSubMatrixIndex(int, int, int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if submatrix ranges indices are valid.
- checkSubMatrixIndex(AnyMatrix, int[], int[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if submatrix ranges indices are valid.
- checkSubMatrixIndex(AnyMatrix, int, int, int, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if submatrix ranges indices are valid.
- checkSubtractionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Check if matrices are subtraction compatible
- checkSubtractionCompatible(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Check if a matrix is subtraction compatible with the instance.
- checkSymmetric(RealMatrix, double) - Static method in class org.hipparchus.linear.MatrixUtils
-
Checks whether a matrix is symmetric.
- checkVectorDimensions(int) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(int) - Method in class org.hipparchus.linear.ArrayRealVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(int) - Method in class org.hipparchus.linear.RealVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(int) - Method in class org.hipparchus.linear.SparseFieldVector
-
Check if instance dimension is equal to some expected value.
- checkVectorDimensions(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Check if instance and specified vectors have the same dimension.
- checkVectorDimensions(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Check if instance and specified vectors have the same dimension.
- chiSquare(double[], long[]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- chiSquare(double[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquare(long[][]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- chiSquare(long[][]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareDataSetsComparison(long[], long[]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- chiSquareDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- ChiSquaredDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the chi-squared distribution.
- ChiSquaredDistribution(double) - Constructor for class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Create a Chi-Squared distribution with the given degrees of freedom.
- ChiSquaredDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Create a Chi-Squared distribution with the given degrees of freedom and
inverse cumulative probability accuracy.
- chiSquareTest(double[], long[]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- chiSquareTest(double[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareTest(double[], long[], double) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
Performs a
Chi-square goodness of fit test evaluating the null hypothesis that the
observed counts conform to the frequency distribution described by the expected
counts, with significance level
alpha
.
- chiSquareTest(double[], long[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareTest(long[][]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
- chiSquareTest(long[][]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareTest(long[][], double) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
Performs a
chi-square test of independence evaluating the null hypothesis that the
classifications represented by the counts in the columns of the input 2-way table
are independent of the rows, with significance level
alpha
.
- chiSquareTest(long[][], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- ChiSquareTest - Class in org.hipparchus.stat.inference
-
Implements Chi-Square test statistics.
- ChiSquareTest() - Constructor for class org.hipparchus.stat.inference.ChiSquareTest
-
Construct a ChiSquareTest
- chiSquareTestDataSetsComparison(long[], long[]) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
Returns the
observed significance level, or
p-value, associated with a Chi-Square two sample test comparing
bin frequency counts in
observed1
and
observed2
.
- chiSquareTestDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- chiSquareTestDataSetsComparison(long[], long[], double) - Method in class org.hipparchus.stat.inference.ChiSquareTest
-
Performs a Chi-Square two sample test comparing two binned data
sets.
- chiSquareTestDataSetsComparison(long[], long[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- CHOLESKY - org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer.Decomposition
-
Deprecated.
- CholeskyDecomposer - Class in org.hipparchus.linear
-
Matrix decomposer using Cholseky decomposition.
- CholeskyDecomposer(double, double) - Constructor for class org.hipparchus.linear.CholeskyDecomposer
-
Creates a Cholesky decomposer with specify threshold for several matrices.
- CholeskyDecomposition - Class in org.hipparchus.linear
-
Calculates the Cholesky decomposition of a matrix.
- CholeskyDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.CholeskyDecomposition
-
Calculates the Cholesky decomposition of the given matrix.
- CholeskyDecomposition(RealMatrix, double, double) - Constructor for class org.hipparchus.linear.CholeskyDecomposition
-
Calculates the Cholesky decomposition of the given matrix.
- Circle - Class in org.hipparchus.geometry.spherical.twod
-
This class represents an oriented great circle on the 2-sphere.
- Circle(Vector3D, double) - Constructor for class org.hipparchus.geometry.spherical.twod.Circle
-
Build a great circle from its pole.
- Circle(Circle) - Constructor for class org.hipparchus.geometry.spherical.twod.Circle
-
Copy constructor.
- Circle(S2Point, S2Point, double) - Constructor for class org.hipparchus.geometry.spherical.twod.Circle
-
Build a great circle from two non-aligned points.
- CLASS_DOESNT_IMPLEMENT_COMPARABLE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CLASS_DOESNT_IMPLEMENT_COMPARABLE - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- ClassicalRungeKuttaFieldIntegrator<T extends RealFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements the classical fourth order Runge-Kutta
integrator for Ordinary Differential Equations (it is the most
often used Runge-Kutta method).
- ClassicalRungeKuttaFieldIntegrator(Field<T>, T) - Constructor for class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
-
Simple constructor.
- ClassicalRungeKuttaIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements the classical fourth order Runge-Kutta
integrator for Ordinary Differential Equations (it is the most
often used Runge-Kutta method).
- ClassicalRungeKuttaIntegrator(double) - Constructor for class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
-
Simple constructor.
- classify() - Method in class org.hipparchus.dfp.Dfp
-
Returns the type - one of FINITE, INFINITE, SNAN, QNAN.
- clear() - Method in class org.hipparchus.fitting.WeightedObservedPoints
-
Removes all observations from this container.
- clear() - Method in class org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
-
Method that will called in order to clear all stored optima.
- clear() - Method in class org.hipparchus.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
-
Method that will called in order to clear all stored optima.
- clear() - Method in class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Resets all statistics and storage.
- clear() - Method in class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.moment.Mean
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.moment.Skewness
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Resets all statistics and storage.
- clear() - Method in class org.hipparchus.stat.descriptive.rank.Max
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.rank.Min
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
- clear() - Method in interface org.hipparchus.stat.descriptive.StorelessMultivariateStatistic
-
Clears the internal state of the statistic.
- clear() - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Resets all statistics and storage.
- clear() - Method in class org.hipparchus.stat.descriptive.summary.Product
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.summary.Sum
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.vector.VectorialCovariance
-
Clears the internal state of the Statistic
- clear() - Method in class org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
-
Clears the internal state of the statistic.
- clear() - Method in class org.hipparchus.stat.Frequency
-
Clears the frequency table
- clear() - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
As the name suggests, clear wipes the internals and reorders everything in the
canonical order.
- clear() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Clears all data from the model.
- clear() - Method in interface org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Clears internal buffers and resets the regression model.
- clear() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Clear the array contents, resetting the number of elements to zero.
- clearEventHandlers() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventHandlers() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventHandlers() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearEventHandlers() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Remove all the event handlers that have been added to the integrator.
- clearIEEEFlags() - Method in class org.hipparchus.dfp.DfpField
-
Clears the IEEE 854 status flags.
- clearStepHandlers() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clearStepHandlers() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clearStepHandlers() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clearStepHandlers() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Remove all the step handlers that have been added to the integrator.
- clone() - Method in interface org.hipparchus.stat.descriptive.rank.PSquarePercentile.PSquareMarkers
-
A clone function to clone the current instance.
- CLOSE_VERTICES - org.hipparchus.geometry.LocalizedGeometryFormats
-
- CLOSE_VERTICES - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CLOSEST_ORTHOGONAL_MATRIX_HAS_NEGATIVE_DETERMINANT - org.hipparchus.geometry.LocalizedGeometryFormats
-
- CLOSEST_ORTHOGONAL_MATRIX_HAS_NEGATIVE_DETERMINANT - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- closestPoint(FieldLine<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Compute the point of the instance closest to another line.
- closestPoint(Line) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Compute the point of the instance closest to another line.
- cluster(Collection<T>) - Method in class org.hipparchus.clustering.Clusterer
-
Perform a cluster analysis on the given set of
Clusterable
instances.
- cluster(Collection<T>) - Method in class org.hipparchus.clustering.DBSCANClusterer
-
Performs DBSCAN cluster analysis.
- cluster(Collection<T>) - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Performs Fuzzy K-Means cluster analysis.
- cluster(Collection<T>) - Method in class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
Runs the K-means++ clustering algorithm.
- cluster(Collection<T>) - Method in class org.hipparchus.clustering.MultiKMeansPlusPlusClusterer
-
Runs the K-means++ clustering algorithm.
- Cluster<T extends Clusterable> - Class in org.hipparchus.clustering
-
- Cluster() - Constructor for class org.hipparchus.clustering.Cluster
-
Build a cluster centered at a specified point.
- Clusterable - Interface in org.hipparchus.clustering
-
Interface for n-dimensional points that can be clustered together.
- ClusterAlgorithmComparison - Class in org.hipparchus.samples
-
Plots clustering results for various algorithms and datasets.
- ClusterAlgorithmComparison() - Constructor for class org.hipparchus.samples.ClusterAlgorithmComparison
-
- ClusterAlgorithmComparison.ClusterPlot - Class in org.hipparchus.samples
-
- ClusterAlgorithmComparison.Display - Class in org.hipparchus.samples
-
- Clusterer<T extends Clusterable> - Class in org.hipparchus.clustering
-
Base class for clustering algorithms.
- Clusterer(DistanceMeasure) - Constructor for class org.hipparchus.clustering.Clusterer
-
- ClusterEvaluator<T extends Clusterable> - Class in org.hipparchus.clustering.evaluation
-
Base class for cluster evaluation methods.
- ClusterEvaluator() - Constructor for class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
- ClusterEvaluator(DistanceMeasure) - Constructor for class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
Creates a new cluster evaluator with the given distance measure.
- ClusterPlot(List<? extends Cluster<DoublePoint>>, long) - Constructor for class org.hipparchus.samples.ClusterAlgorithmComparison.ClusterPlot
-
- CMAESOptimizer - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
An implementation of the active Covariance Matrix Adaptation Evolution Strategy (CMA-ES)
for non-linear, non-convex, non-smooth, global function minimization.
- CMAESOptimizer(int, double, boolean, int, int, RandomGenerator, boolean, ConvergenceChecker<PointValuePair>) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- CMAESOptimizer.PopulationSize - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
Population size.
- CMAESOptimizer.Sigma - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
Input sigma values.
- collector(BivariateFunction, double) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Returns a MultivariateFunction h(x[]) defined by
- collector(BivariateFunction, UnivariateFunction, double) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Returns a MultivariateFunction h(x[]) defined by
- COLUMN_INDEX - org.hipparchus.exception.LocalizedCoreFormats
-
- COLUMN_INDEX - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- COLUMN_INDEX_OUT_OF_RANGE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- COLUMN_INDEX_OUT_OF_RANGE - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- Combinations - Class in org.hipparchus.util
-
Utility to create combinations (n, k)
of k
elements
in a set of n
elements.
- Combinations(int, int) - Constructor for class org.hipparchus.util.Combinations
-
Creates an instance whose range is the k-element subsets of
{0, ..., n - 1} represented as int[]
arrays.
- combinationsIterator(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
Returns an iterator whose range is the k-element subsets of {0, ..., n - 1}
represented as int[]
arrays.
- CombinatoricsUtils - Class in org.hipparchus.util
-
Combinatorial utilities.
- CombinatoricsUtils.FactorialLog - Class in org.hipparchus.util
-
Class for computing the natural logarithm of the factorial of n
.
- combine(double, double, RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Returns a new vector representing a * this + b * y
, the linear
combination of this
and y
.
- combine(double, double, RealVector) - Method in class org.hipparchus.linear.RealVector
-
Returns a new vector representing a * this + b * y
, the linear
combination of this
and y
.
- combine(BivariateFunction, UnivariateFunction, UnivariateFunction) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Returns the univariate function
h(x) = combiner(f(x), g(x)).
- combineToSelf(double, double, RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Updates this
with the linear combination of this
and
y
.
- combineToSelf(double, double, RealVector) - Method in class org.hipparchus.linear.RealVector
-
Updates this
with the linear combination of this
and
y
.
- comparator() - Method in class org.hipparchus.util.Combinations
-
Defines a lexicographic ordering of combinations.
- compare(Complex, Complex) - Method in class org.hipparchus.complex.ComplexComparator
-
Compare two complex numbers, using real ordering as the primary sort order and
imaginary ordering as the secondary sort order.
- compareTo(double, double, double) - Static method in class org.hipparchus.util.Precision
-
Compares two numbers given some amount of allowed error.
- compareTo(double, double, int) - Static method in class org.hipparchus.util.Precision
-
Compares two numbers given some amount of allowed error.
- compareTo(BigFraction) - Method in class org.hipparchus.fraction.BigFraction
-
Compares this object to another based on size.
- compareTo(Fraction) - Method in class org.hipparchus.fraction.Fraction
-
Compares this object to another based on size.
- compareTo(BigReal) - Method in class org.hipparchus.util.BigReal
- compareTo(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
The current implementation returns the same value as
new Double(this.doubleValue()).compareTo(new
Double(o.doubleValue()))
- complainIfNotSupported(String) - Method in class org.hipparchus.ode.AbstractParameterizable
-
Check if a parameter is supported and throw an IllegalArgumentException if not.
- complement(int) - Method in class org.hipparchus.dfp.Dfp
-
Negate the mantissa of this by computing the complement.
- Complex - Class in org.hipparchus.complex
-
Representation of a Complex number, i.e.
- Complex(double) - Constructor for class org.hipparchus.complex.Complex
-
Create a complex number given only the real part.
- Complex(double, double) - Constructor for class org.hipparchus.complex.Complex
-
Create a complex number given the real and imaginary parts.
- COMPLEX_CANNOT_BE_CONSIDERED_A_REAL_NUMBER - org.hipparchus.exception.LocalizedCoreFormats
-
- ComplexComparator - Class in org.hipparchus.complex
-
Comparator for Complex Numbers.
- ComplexComparator() - Constructor for class org.hipparchus.complex.ComplexComparator
-
- ComplexEigenDecomposition - Class in org.hipparchus.linear
-
Given a matrix A, it computes a complex eigen decomposition A = VDV^{T}.
- ComplexEigenDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.ComplexEigenDecomposition
-
Constructor for decomposition.
- ComplexField - Class in org.hipparchus.complex
-
Representation of the complex numbers field.
- ComplexFormat - Class in org.hipparchus.complex
-
Formats a Complex number in cartesian format "Re(c) + Im(c)i".
- ComplexFormat() - Constructor for class org.hipparchus.complex.ComplexFormat
-
Create an instance with the default imaginary character, 'i', and the
default number format for both real and imaginary parts.
- ComplexFormat(String) - Constructor for class org.hipparchus.complex.ComplexFormat
-
Create an instance with a custom imaginary character, and the default
number format for both real and imaginary parts.
- ComplexFormat(String, NumberFormat) - Constructor for class org.hipparchus.complex.ComplexFormat
-
Create an instance with a custom imaginary character, and a custom number
format for both real and imaginary parts.
- ComplexFormat(String, NumberFormat, NumberFormat) - Constructor for class org.hipparchus.complex.ComplexFormat
-
Create an instance with a custom imaginary character, a custom number
format for the real part, and a custom number format for the imaginary
part.
- ComplexFormat(NumberFormat) - Constructor for class org.hipparchus.complex.ComplexFormat
-
Create an instance with a custom number format for both real and
imaginary parts.
- ComplexFormat(NumberFormat, NumberFormat) - Constructor for class org.hipparchus.complex.ComplexFormat
-
Create an instance with a custom number format for the real part and a
custom number format for the imaginary part.
- ComplexUtils - Class in org.hipparchus.complex
-
Static implementations of common
Complex
utilities functions.
- compose(double...) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute composition of the instance by a univariate function.
- compose(double...) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute composition of the instance by a univariate function.
- compose(double[], int, double[], double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute composition of a derivative structure by a function.
- compose(double, double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute composition of the instance by a univariate function.
- compose(UnivariateDifferentiableFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Composes functions.
- compose(UnivariateFunction...) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Composes functions.
- compose(FieldRotation<T>, RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Compose the instance with another rotation.
- compose(Rotation, RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Compose the instance with another rotation.
- compose(Rotation, RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Compose the instance with another rotation.
- compose(T...) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute composition of the instance by a univariate function.
- compose(T[], int, double[], T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute composition of a derivative structure by a function.
- compose(T[], int, T[], T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute composition of a derivative structure by a function.
- composeInverse(FieldRotation<T>, RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Compose the inverse of the instance with another rotation.
- composeInverse(Rotation, RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Compose the inverse of the instance with another rotation.
- composeInverse(Rotation, RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Compose the inverse of the instance with another rotation.
- CompositeFormat - Class in org.hipparchus.util
-
Base class for formatters of composite objects (complex numbers, vectors ...).
- compute(double[], double[]) - Method in class org.hipparchus.clustering.distance.CanberraDistance
-
Compute the distance between two n-dimensional vectors.
- compute(double[], double[]) - Method in class org.hipparchus.clustering.distance.ChebyshevDistance
-
Compute the distance between two n-dimensional vectors.
- compute(double[], double[]) - Method in interface org.hipparchus.clustering.distance.DistanceMeasure
-
Compute the distance between two n-dimensional vectors.
- compute(double[], double[]) - Method in class org.hipparchus.clustering.distance.EarthMoversDistance
-
Compute the distance between two n-dimensional vectors.
- compute(double[], double[]) - Method in class org.hipparchus.clustering.distance.EuclideanDistance
-
Compute the distance between two n-dimensional vectors.
- compute(double[], double[]) - Method in class org.hipparchus.clustering.distance.ManhattanDistance
-
Compute the distance between two n-dimensional vectors.
- compute(MathArrays.Function) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Performs an operation on the addressable elements of the array.
- computeCoefficients() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Calculate the coefficients of Lagrange polynomial from the
interpolation data.
- computeCoefficients() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Calculate the normal polynomial coefficients given the Newton form.
- computeCorrelationMatrix(double[][]) - Method in class org.hipparchus.stat.correlation.KendallsCorrelation
-
Computes the Kendall's Tau rank correlation matrix for the columns of
the input rectangular array.
- computeCorrelationMatrix(double[][]) - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Computes the correlation matrix for the columns of the
input rectangular array.
- computeCorrelationMatrix(double[][]) - Method in class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation matrix for the columns of the
input rectangular array.
- computeCorrelationMatrix(RealMatrix) - Method in class org.hipparchus.stat.correlation.KendallsCorrelation
-
Computes the Kendall's Tau rank correlation matrix for the columns of
the input matrix.
- computeCorrelationMatrix(RealMatrix) - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
- computeCorrelationMatrix(RealMatrix) - Method in class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation matrix for the columns of the
input matrix.
- computeCovarianceMatrix(double[][]) - Method in class org.hipparchus.stat.correlation.Covariance
-
Create a covariance matrix from a rectangular array whose columns represent
covariates.
- computeCovarianceMatrix(double[][], boolean) - Method in class org.hipparchus.stat.correlation.Covariance
-
Compute a covariance matrix from a rectangular array whose columns represent covariates.
- computeCovarianceMatrix(RealMatrix) - Method in class org.hipparchus.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns represent
covariates.
- computeCovarianceMatrix(RealMatrix, boolean) - Method in class org.hipparchus.stat.correlation.Covariance
-
Compute a covariance matrix from a matrix whose columns represent covariates.
- computeDerivatives(double, double[]) - Method in interface org.hipparchus.migration.ode.FirstOrderDifferentialEquations
-
Deprecated.
Get the current time derivative of the state vector.
- computeDerivatives(double, double[]) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Compute the derivatives and check the number of evaluations.
- computeDerivatives(double, double[]) - Method in class org.hipparchus.ode.ExpandableODE
-
Get the current time derivative of the complete state vector.
- computeDerivatives(double, double[]) - Method in class org.hipparchus.ode.FirstOrderConverter
-
Get the current time derivative of the state vector.
- computeDerivatives(double, double[]) - Method in interface org.hipparchus.ode.OrdinaryDifferentialEquation
-
Get the current time derivative of the state vector.
- computeDerivatives(double, double[], double[]) - Method in interface org.hipparchus.migration.ode.FirstOrderDifferentialEquations
-
Deprecated.
Get the current time derivative of the state vector.
- computeDerivatives(double, double[], double[], double[]) - Method in interface org.hipparchus.migration.ode.SecondaryEquations
-
Deprecated.
Compute the derivatives related to the secondary state parameters.
- computeDerivatives(double, double[], double[], double[]) - Method in interface org.hipparchus.ode.SecondaryODE
-
Compute the derivatives related to the secondary state parameters.
- computeDerivatives(double, double[], double[], double[], double[]) - Method in interface org.hipparchus.migration.ode.SecondaryEquations
-
Deprecated.
Compute the derivatives related to the secondary state parameters.
- computeDerivatives(T, T[]) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Compute the derivatives and check the number of evaluations.
- computeDerivatives(T, T[]) - Method in class org.hipparchus.ode.FieldExpandableODE
-
Get the current time derivative of the complete state vector.
- computeDerivatives(T, T[]) - Method in interface org.hipparchus.ode.FieldOrdinaryDifferentialEquation
-
Get the current time derivative of the state vector.
- computeDerivatives(T, T[], T[], T[]) - Method in interface org.hipparchus.ode.FieldSecondaryODE
-
Compute the derivatives related to the secondary state parameters.
- computeDividedDifference(double[], double[]) - Static method in class org.hipparchus.analysis.interpolation.DividedDifferenceInterpolator
-
Return a copy of the divided difference array.
- computeExp(Dfp, Dfp) - Static method in class org.hipparchus.dfp.DfpField
-
Compute exp(a).
- computeGeometricalProperties() - Method in class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class org.hipparchus.geometry.euclidean.twod.PolygonsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Compute some geometrical properties.
- computeGeometricalProperties() - Method in class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Compute some geometrical properties.
- computeInnovationCovarianceMatrix(RealMatrix, RealMatrix) - Method in class org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Compute innovation covariance matrix.
- computeInterpolatedStateAndDerivatives(EquationsMapper, double, double, double, double) - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Compute the state and derivatives at the interpolated time.
- computeInterpolatedStateAndDerivatives(FieldEquationsMapper<T>, T, T, T, T) - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Compute the state and derivatives at the interpolated time.
- computeJacobian(double[]) - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.ValueAndJacobianFunction
-
Compute the Jacobian.
- computeLn(Dfp, Dfp, Dfp) - Static method in class org.hipparchus.dfp.DfpField
-
Compute ln(a).
- computeMainStateJacobian(double, double[], double[]) - Method in interface org.hipparchus.migration.ode.MainStateJacobianProvider
-
Deprecated.
Compute the jacobian matrix of ODE with respect to main state.
- computeMainStateJacobian(double, double[], double[]) - Method in interface org.hipparchus.ode.ODEJacobiansProvider
-
Compute the Jacobian matrix of ODE with respect to state.
- computeObjectiveGradient(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.GradientMultivariateOptimizer
-
Compute the gradient vector.
- computeObjectiveValue(double) - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Compute the objective function value.
- computeObjectiveValue(double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Compute the objective function value.
- computeObjectiveValue(double) - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
Computes the objective function value.
- computeObjectiveValue(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.MultivariateOptimizer
-
Computes the objective function value.
- computeObjectiveValueAndDerivative(double) - Method in class org.hipparchus.analysis.solvers.AbstractUnivariateDifferentiableSolver
-
Compute the objective function value.
- computeParameterJacobian(double, double[], double[], String) - Method in interface org.hipparchus.migration.ode.ParameterJacobianProvider
-
Deprecated.
Compute the Jacobian matrix of ODE with respect to one parameter.
- computeParameterJacobian(double, double[], double[], String) - Method in interface org.hipparchus.ode.NamedParameterJacobianProvider
-
Compute the Jacobian matrix of ODE with respect to one parameter.
- computeParameterJacobian(double, double[], double[], String) - Method in interface org.hipparchus.ode.ODEJacobiansProvider
-
Compute the Jacobian matrix of ODE with respect to one parameter.
- computeParameterJacobian(double, double[], double[], String, double[]) - Method in interface org.hipparchus.migration.ode.ParameterJacobianProvider
-
Deprecated.
Compute the Jacobian matrix of ODE with respect to one parameter.
- computeRoots(int) - Method in class org.hipparchus.complex.RootsOfUnity
-
Computes the n
-th roots of unity.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.BaseRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.HermiteRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.LaguerreRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.LegendreHighPrecisionRuleFactory
-
Computes the rule for the given order.
- computeRule(int) - Method in class org.hipparchus.analysis.integration.gauss.LegendreRuleFactory
-
Computes the rule for the given order.
- computeSecondDerivatives(double, double[], double[]) - Method in interface org.hipparchus.migration.ode.SecondOrderDifferentialEquations
-
Deprecated.
Get the current time derivative of the state vector.
- computeSecondDerivatives(double, double[], double[]) - Method in interface org.hipparchus.ode.SecondOrderODE
-
Get the current time derivative of the state vector.
- computeSecondDerivatives(double, double[], double[], double[]) - Method in interface org.hipparchus.migration.ode.SecondOrderDifferentialEquations
-
Deprecated.
Get the current time derivative of the state vector.
- computeStepGrowShrinkFactor(double) - Method in class org.hipparchus.ode.MultistepIntegrator
-
Compute step grow/shrink factor according to normalized error.
- computeStepGrowShrinkFactor(T) - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Compute step grow/shrink factor according to normalized error.
- computeValue(double[]) - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.ValueAndJacobianFunction
-
Compute the value.
- concatenate(double[]...) - Static method in class org.hipparchus.util.MathArrays
-
Concatenates a sequence of arrays.
- ConfidenceInterval - Class in org.hipparchus.stat.interval
-
Represents an interval estimate of a population parameter.
- ConfidenceInterval(double, double, double) - Constructor for class org.hipparchus.stat.interval.ConfidenceInterval
-
Create a confidence interval with the given bounds and confidence level.
- conjugate() - Method in class org.hipparchus.complex.Complex
-
Returns the conjugate of this complex number.
- ConjugateGradient - Class in org.hipparchus.linear
-
- ConjugateGradient(int, double, boolean) - Constructor for class org.hipparchus.linear.ConjugateGradient
-
- ConjugateGradient(IterationManager, double, boolean) - Constructor for class org.hipparchus.linear.ConjugateGradient
-
- constant(double) - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
- constant(double) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
- constant(T) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
- Constant - Class in org.hipparchus.analysis.function
-
Constant function.
- Constant(double) - Constructor for class org.hipparchus.analysis.function.Constant
-
- ConstantRealDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the constant real distribution.
- ConstantRealDistribution(double) - Constructor for class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Create a constant real distribution with the given value.
- CONSTRAINT - org.hipparchus.exception.LocalizedCoreFormats
-
- CONSTRAINT - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- contains(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Check if the instance contains a point.
- contains(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Check if the instance contains a point.
- contains(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Check if the instance contains a point.
- contains(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Check if the instance contains a point.
- contains(Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Check if the line contains a point.
- contains(Region<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check if the instance entirely contains another region.
- contains(Region<S>) - Method in interface org.hipparchus.geometry.partitioning.Region
-
Check if the instance entirely contains another region.
- contains(P) - Method in class org.hipparchus.geometry.enclosing.EnclosingBall
-
Check if a point is within the ball or at boundary.
- contains(P, double) - Method in class org.hipparchus.geometry.enclosing.EnclosingBall
-
Check if a point is within an enlarged ball or at boundary.
- containsKey(int) - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
-
Check if a value is associated with a key.
- containsKey(int) - Method in class org.hipparchus.util.OpenIntToFieldHashMap
-
Check if a value is associated with a key.
- CONTINUE - org.hipparchus.migration.ode.events.EventHandler.Action
-
Deprecated.
Continue indicator.
- CONTINUE - org.hipparchus.ode.events.Action
-
Continue indicator.
- CONTINUED_FRACTION_INFINITY_DIVERGENCE - org.hipparchus.exception.LocalizedCoreFormats
-
- CONTINUED_FRACTION_INFINITY_DIVERGENCE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CONTINUED_FRACTION_NAN_DIVERGENCE - org.hipparchus.exception.LocalizedCoreFormats
-
- CONTINUED_FRACTION_NAN_DIVERGENCE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ContinuedFraction - Class in org.hipparchus.util
-
Provides a generic means to evaluate continued fractions.
- ContinuedFraction() - Constructor for class org.hipparchus.util.ContinuedFraction
-
Default constructor.
- ContinuousOutputModel - Class in org.hipparchus.migration.ode
-
- ContinuousOutputModel() - Constructor for class org.hipparchus.migration.ode.ContinuousOutputModel
-
Deprecated.
- contract() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Contracts the storage array to the (size of the element set) + 1 - to avoid
a zero length array.
- CONTRACTION_CRITERIA_SMALLER_THAN_EXPANSION_FACTOR - org.hipparchus.exception.LocalizedCoreFormats
-
- CONTRACTION_CRITERIA_SMALLER_THAN_EXPANSION_FACTOR - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- CONTRACTION_CRITERIA_SMALLER_THAN_ONE - org.hipparchus.exception.LocalizedCoreFormats
-
- CONTRACTION_CRITERIA_SMALLER_THAN_ONE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- converged(int, LeastSquaresProblem.Evaluation, LeastSquaresProblem.Evaluation) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.EvaluationRmsChecker
-
Check if the optimization algorithm has converged.
- converged(int, PointValuePair, PointValuePair) - Method in class org.hipparchus.optim.SimpleValueChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- converged(int, PointVectorValuePair, PointVectorValuePair) - Method in class org.hipparchus.optim.SimpleVectorValueChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- converged(int, UnivariatePointValuePair, UnivariatePointValuePair) - Method in class org.hipparchus.optim.univariate.SimpleUnivariateValueChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- converged(int, PAIR, PAIR) - Method in class org.hipparchus.optim.AbstractConvergenceChecker
-
Check if the optimization algorithm has converged.
- converged(int, PAIR, PAIR) - Method in interface org.hipparchus.optim.ConvergenceChecker
-
Check if the optimization algorithm has converged.
- converged(int, PAIR, PAIR) - Method in class org.hipparchus.optim.SimplePointChecker
-
Check if the optimization algorithm has converged considering the
last two points.
- CONVERGENCE_FAILED - org.hipparchus.exception.LocalizedCoreFormats
-
- CONVERGENCE_FAILED - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ConvergenceChecker<PAIR> - Interface in org.hipparchus.optim
-
This interface specifies how to check if an optimization algorithm has
converged.
- ConvergenceException - Exception in org.hipparchus.migration.exception
-
- ConvergenceException() - Constructor for exception org.hipparchus.migration.exception.ConvergenceException
-
Deprecated.
Construct the exception.
- ConvergenceException(Localizable, Object...) - Constructor for exception org.hipparchus.migration.exception.ConvergenceException
-
Deprecated.
Construct the exception with a specific context and arguments.
- convertToComplex(double[]) - Static method in class org.hipparchus.complex.ComplexUtils
-
Convert an array of primitive doubles to an array of Complex
objects.
- ConvexHull<S extends Space,P extends Point<S>> - Interface in org.hipparchus.geometry.hull
-
This class represents a convex hull.
- ConvexHull2D - Class in org.hipparchus.geometry.euclidean.twod.hull
-
This class represents a convex hull in an two-dimensional euclidean space.
- ConvexHull2D(Vector2D[], double) - Constructor for class org.hipparchus.geometry.euclidean.twod.hull.ConvexHull2D
-
Simple constructor.
- ConvexHullGenerator<S extends Space,P extends Point<S>> - Interface in org.hipparchus.geometry.hull
-
Interface for convex hull generators.
- ConvexHullGenerator2D - Interface in org.hipparchus.geometry.euclidean.twod.hull
-
Interface for convex hull generators in the two-dimensional euclidean space.
- convolve(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
- copy() - Method in class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Perform a copy.
- copy() - Method in class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere2D
-
Perform a copy.
- copy() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.ArrayFieldVector
-
Returns a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.ArrayRealVector
-
Returns a (deep) copy of this vector.
- copy() - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns a (deep) copy of this.
- copy() - Method in interface org.hipparchus.linear.FieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in interface org.hipparchus.linear.FieldVector
-
Returns a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.OpenMapRealVector
-
Returns a (deep) copy of this vector.
- copy() - Method in interface org.hipparchus.linear.RealMatrix
-
Returns a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.RealVector
-
Returns a (deep) copy of this vector.
- copy() - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Make a (deep) copy of this.
- copy() - Method in class org.hipparchus.linear.SparseFieldVector
-
Returns a (deep) copy of this.
- copy() - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
Deprecated.
Copy the instance.
- copy() - Method in class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns a copy of this DescriptiveStatistics instance with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.moment.Mean
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.moment.Skewness
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.rank.Max
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.rank.Median
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.rank.Min
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
- copy() - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns a copy of this StreamingStatistics instance with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.summary.Product
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.summary.Sum
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in interface org.hipparchus.stat.descriptive.UnivariateStatistic
-
Returns a copy of the statistic with the same internal state.
- copy() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Returns a copy of the ResizableDoubleArray.
- copy(double[][]) - Method in class org.hipparchus.ode.ODEState
-
Copy a two-dimensions array.
- copy(T[][]) - Method in class org.hipparchus.ode.FieldODEState
-
Copy a two-dimensions array.
- copySelf() - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Copy the instance.
- copySelf() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Copy the instance.
- copySelf() - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Copy the instance.
- copySelf() - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Copy the instance.
- copySelf() - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Copy the instance.
- copySelf() - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Copy the instance.
- copySelf() - Method in interface org.hipparchus.geometry.partitioning.Hyperplane
-
Copy the instance.
- copySelf() - Method in interface org.hipparchus.geometry.partitioning.Region
-
Copy the instance.
- copySelf() - Method in interface org.hipparchus.geometry.partitioning.SubHyperplane
-
Copy the instance.
- copySelf() - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Copy the instance.
- copySelf() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Copy the instance.
- copysign(Dfp, Dfp) - Static method in class org.hipparchus.dfp.Dfp
-
Creates an instance that is the same as x except that it has the sign of y.
- copySign(byte, byte) - Static method in class org.hipparchus.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySign(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.dfp.Dfp
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in interface org.hipparchus.RealFieldElement
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.util.Decimal64
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.util.FieldTuple
-
Returns the instance with the sign of the argument.
- copySign(double) - Method in class org.hipparchus.util.Tuple
-
Returns the instance with the sign of the argument.
- copySign(double, double) - Static method in class org.hipparchus.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySign(float, float) - Static method in class org.hipparchus.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySign(int, int) - Static method in class org.hipparchus.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySign(long, long) - Static method in class org.hipparchus.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySign(short, short) - Static method in class org.hipparchus.util.MathUtils
-
Returns the first argument with the sign of the second argument.
- copySign(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Returns the instance with the sign of the argument.
- copySign(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Returns the instance with the sign of the argument.
- copySign(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Returns the instance with the sign of the argument.
- copySign(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Returns the instance with the sign of the argument.
- copySign(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
Returns the instance with the sign of the argument.
- copySign(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Returns the instance with the sign of the argument.
- copySign(Tuple) - Method in class org.hipparchus.util.Tuple
-
Returns the instance with the sign of the argument.
- copySign(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Returns the instance with the sign of the argument.
- copySign(T) - Method in interface org.hipparchus.RealFieldElement
-
Returns the instance with the sign of the argument.
- copySign(T, double) - Static method in class org.hipparchus.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySign(T, T) - Static method in class org.hipparchus.util.FastMath
-
Returns the first argument with the sign of the second argument.
- copySubMatrix(int[], int[], double[][]) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], double[][]) - Method in interface org.hipparchus.linear.RealMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], T[][]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Copy a submatrix.
- copySubMatrix(int[], int[], T[][]) - Method in interface org.hipparchus.linear.FieldMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, double[][]) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, double[][]) - Method in interface org.hipparchus.linear.RealMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, T[][]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Copy a submatrix.
- copySubMatrix(int, int, int, int, T[][]) - Method in interface org.hipparchus.linear.FieldMatrix
-
Copy a submatrix.
- correct(T, RealVector, RealMatrix, RealMatrix) - Method in class org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Perform correction step.
- CorrelatedRandomVectorGenerator - Class in org.hipparchus.random
-
- CorrelatedRandomVectorGenerator(double[], RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.hipparchus.random.CorrelatedRandomVectorGenerator
-
Builds a correlated random vector generator from its mean
vector and covariance matrix.
- CorrelatedRandomVectorGenerator(RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.hipparchus.random.CorrelatedRandomVectorGenerator
-
Builds a null mean random correlated vector generator from its
covariance matrix.
- correlation(double[], double[]) - Method in class org.hipparchus.stat.correlation.KendallsCorrelation
-
Computes the Kendall's Tau rank correlation coefficient between the two arrays.
- correlation(double[], double[]) - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Computes the Pearson's product-moment correlation coefficient between two arrays.
- correlation(double[], double[]) - Method in class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Computes the Spearman's rank correlation coefficient between the two arrays.
- cos() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Cosine operation.
- cos() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Cosine operation.
- cos() - Method in class org.hipparchus.complex.Complex
-
Compute the
cosine of this complex number.
- cos() - Method in class org.hipparchus.dfp.Dfp
-
Cosine operation.
- cos() - Method in interface org.hipparchus.RealFieldElement
-
Cosine operation.
- cos() - Method in class org.hipparchus.util.Decimal64
-
Cosine operation.
- cos() - Method in class org.hipparchus.util.FieldTuple
-
Cosine operation.
- cos() - Method in class org.hipparchus.util.SinCos
-
Get the value of the cosine.
- cos() - Method in class org.hipparchus.util.Tuple
-
Cosine operation.
- cos(double) - Static method in class org.hipparchus.util.FastMath
-
Cosine function.
- cos(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute cosine of a derivative structure.
- cos(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the cosine of the argument.
- cos(T) - Static method in class org.hipparchus.util.FastMath
-
Cosine function.
- cos(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute cosine of a derivative structure.
- Cos - Class in org.hipparchus.analysis.function
-
Cosine function.
- Cos() - Constructor for class org.hipparchus.analysis.function.Cos
-
- cosAngle(double[], double[]) - Static method in class org.hipparchus.util.MathArrays
-
Calculates the cosine of the angle between two vectors.
- cosh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.complex.Complex
-
- cosh() - Method in class org.hipparchus.dfp.Dfp
-
Hyperbolic cosine operation.
- cosh() - Method in interface org.hipparchus.RealFieldElement
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.util.Decimal64
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.util.FieldTuple
-
Hyperbolic cosine operation.
- cosh() - Method in class org.hipparchus.util.Tuple
-
Hyperbolic cosine operation.
- cosh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the hyperbolic cosine of a number.
- cosh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute hyperbolic cosine of a derivative structure.
- cosh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the hyperbolic cosine of a number.
- cosh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute hyperbolic cosine of a derivative structure.
- Cosh - Class in org.hipparchus.analysis.function
-
Hyperbolic cosine function.
- Cosh() - Constructor for class org.hipparchus.analysis.function.Cosh
-
- cosine(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Computes the cosine of the angle between this vector and the
argument.
- cosInternal(Dfp[]) - Static method in class org.hipparchus.dfp.DfpMath
-
Computes cos(a) Used when 0 < a < pi/4.
- countEvaluations(LeastSquaresProblem, Incrementor) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
Count the evaluations of a particular problem.
- covariance(double[], double[]) - Method in class org.hipparchus.stat.correlation.Covariance
-
Computes the covariance between the two arrays, using the bias-corrected
formula.
- covariance(double[], double[], boolean) - Method in class org.hipparchus.stat.correlation.Covariance
-
Computes the covariance between the two arrays.
- Covariance - Class in org.hipparchus.stat.correlation
-
Computes covariances for pairs of arrays or columns of a matrix.
- Covariance() - Constructor for class org.hipparchus.stat.correlation.Covariance
-
Create a Covariance with no data.
- Covariance(double[][]) - Constructor for class org.hipparchus.stat.correlation.Covariance
-
Create a Covariance matrix from a rectangular array
whose columns represent covariates.
- Covariance(double[][], boolean) - Constructor for class org.hipparchus.stat.correlation.Covariance
-
Create a Covariance matrix from a rectangular array
whose columns represent covariates.
- Covariance(RealMatrix) - Constructor for class org.hipparchus.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns
represent covariates.
- Covariance(RealMatrix, boolean) - Constructor for class org.hipparchus.stat.correlation.Covariance
-
Create a covariance matrix from a matrix whose columns
represent covariates.
- COVARIANCE_MATRIX - org.hipparchus.exception.LocalizedCoreFormats
-
Deprecated.
- COVARIANCE_MATRIX - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- COVARIANCE_MATRIX - org.hipparchus.stat.LocalizedStatFormats
-
- covarianceToCorrelation(RealMatrix) - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Derives a correlation matrix from a covariance matrix.
- create() - Static method in class org.hipparchus.fitting.GaussianCurveFitter
-
Creates a default curve fitter.
- create() - Static method in class org.hipparchus.fitting.HarmonicCurveFitter
-
Creates a default curve fitter.
- create() - Static method in class org.hipparchus.util.CombinatoricsUtils.FactorialLog
-
Creates an instance with no precomputed values.
- create(boolean, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Create a new instance.
- create(boolean, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Create a new instance.
- create(int) - Static method in class org.hipparchus.fitting.PolynomialCurveFitter
-
Creates a default curve fitter.
- create(K, V) - Static method in class org.hipparchus.util.Pair
-
- create(MultivariateVectorFunction, MultivariateMatrixFunction, double[], double[], RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
- create(ParametricUnivariateFunction, double[]) - Static method in class org.hipparchus.fitting.SimpleCurveFitter
-
Creates a curve fitter.
- create(RealLinearOperator) - Static method in class org.hipparchus.linear.JacobiPreconditioner
-
Creates a new instance of this class.
- create(MultivariateJacobianFunction, RealVector, RealVector, RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
- create(MultivariateJacobianFunction, RealVector, RealVector, RealMatrix, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int, boolean, ParameterValidator) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
- create(MultivariateJacobianFunction, RealVector, RealVector, ConvergenceChecker<LeastSquaresProblem.Evaluation>, int, int) - Static method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresFactory
-
- createBlocksLayout(int, int) - Static method in class org.hipparchus.linear.BlockRealMatrix
-
Create a data array in blocks layout.
- createBlocksLayout(Field<T>, int, int) - Static method in class org.hipparchus.linear.BlockFieldMatrix
-
Create a data array in blocks layout.
- createCanvas() - Static method in class org.hipparchus.samples.geometry.GeometryExample
-
- createChart(String, int, int, StyleManager.LegendPosition) - Static method in class org.hipparchus.samples.IntegerDistributionComparison
-
- createChart(String, int, int, StyleManager.LegendPosition) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
- createChebyshevPolynomial(int) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Create a Chebyshev polynomial of the first kind.
- createCircle(int) - Static method in class org.hipparchus.samples.geometry.GeometryExample
-
- createColumnFieldMatrix(T[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Creates a column
FieldMatrix
using the data from the input
array.
- createColumnRealMatrix(double[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Creates a column
RealMatrix
using the data from the input
array.
- createComplex(double, double) - Method in class org.hipparchus.complex.Complex
-
Create a complex number given the real and imaginary parts.
- createComplexArray(double[][]) - Static method in class org.hipparchus.transform.TransformUtils
-
Builds a new array of
Complex
from the specified two dimensional
array of real and imaginary parts.
- createComponent(String, int, int, String[], IntegerDistribution...) - Static method in class org.hipparchus.samples.IntegerDistributionComparison
-
- createComponent(String, int, int, String[], RealDistribution...) - Static method in class org.hipparchus.samples.RealDistributionComparison
-
- createConstant(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
- createConstant(double) - Static method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Factory method creating a constant.
- createCross() - Static method in class org.hipparchus.samples.geometry.GeometryExample
-
- createFieldDiagonalMatrix(T[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns a diagonal matrix with specified elements.
- createFieldIdentityMatrix(Field<T>, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns dimension x dimension
identity matrix.
- createFieldMatrix(Field<T>, int, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
- createFieldMatrix(T[][]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns a
FieldMatrix
whose entries are the the values in the
the input array.
- createFieldVector(Field<T>, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
- createFieldVector(T[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Creates a
FieldVector
using the data from the input array.
- createHermitePolynomial(int) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Create a Hermite polynomial.
- createInternalError() - Static method in exception org.hipparchus.exception.MathRuntimeException
-
Create an exception for an internal error.
- createInternalError(Throwable) - Static method in exception org.hipparchus.exception.MathRuntimeException
-
Create an exception for an internal error.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.EulerIntegrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.GillIntegrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.LutherIntegrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.MidpointIntegrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.RungeKuttaIntegrator
-
Create an interpolator.
- createInterpolator(boolean, double[][], ODEStateAndDerivative, ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.EulerFieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.GillFieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.LutherFieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.MidpointFieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Create an interpolator.
- createInterpolator(boolean, T[][], FieldODEStateAndDerivative<T>, FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
-
Create an interpolator.
- createJacobiPolynomial(int, int, int) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Create a Jacobi polynomial.
- createLaguerrePolynomial(int) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Create a Laguerre polynomial.
- createLegendrePolynomial(int) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Create a Legendre polynomial.
- createMatrix(int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Create a new RealMatrix of the same type as the instance with the
supplied
row and column dimensions.
- createMatrix(int, int) - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Create a new FieldMatrix of the same type as the instance with
the supplied row and column dimensions.
- createRandomPoints(int) - Static method in class org.hipparchus.samples.geometry.GeometryExample
-
- createRealDiagonalMatrix(double[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns a diagonal matrix with specified elements.
- createRealIdentityMatrix(int) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns dimension x dimension
identity matrix.
- createRealImaginaryArray(Complex[]) - Static method in class org.hipparchus.transform.TransformUtils
-
Builds a new two dimensional array of
double
filled with the real
and imaginary parts of the specified
Complex
numbers.
- createRealMatrix(double[][]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Returns a
RealMatrix
whose entries are the the values in the
the input array.
- createRealMatrix(int, int) - Static method in class org.hipparchus.linear.MatrixUtils
-
- createRealVector(double[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Creates a
RealVector
using the data from the input array.
- createRealVector(int) - Static method in class org.hipparchus.linear.MatrixUtils
-
- createRegion() - Method in class org.hipparchus.geometry.euclidean.twod.hull.ConvexHull2D
-
Returns a new region that is enclosed by the convex hull.
- createRegion() - Method in interface org.hipparchus.geometry.hull.ConvexHull
-
Returns a new region that is enclosed by the convex hull.
- createRowFieldMatrix(T[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Create a row
FieldMatrix
using the data from the input
array.
- createRowRealMatrix(double[]) - Static method in class org.hipparchus.linear.MatrixUtils
-
Create a row
RealMatrix
using the data from the input
array.
- createVariable(int, double) - Static method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Factory method creating an independent variable.
- CROSSING_BOUNDARY_LOOPS - org.hipparchus.geometry.LocalizedGeometryFormats
-
- CROSSING_BOUNDARY_LOOPS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- crossProduct(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of the instance with another vector.
- crossProduct(FieldVector3D<T>, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of two vectors.
- crossProduct(FieldVector3D<T>, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of two vectors.
- crossProduct(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of the instance with another vector.
- crossProduct(Vector3D, FieldVector3D<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Compute the cross-product of two vectors.
- crossProduct(Vector3D, Vector3D) - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the cross-product of two vectors.
- crossProduct(Vector2D, Vector2D) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Compute the cross-product of the instance and the given points.
- crossProduct(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Compute the cross-product of the instance with another vector.
- CUMULATIVE_PROBABILITY_RETURNED_NAN - org.hipparchus.exception.LocalizedCoreFormats
-
- CUMULATIVE_PROBABILITY_RETURNED_NAN - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.FDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.TDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.UniformRealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in interface org.hipparchus.distribution.RealDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(double) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.UniformIntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- cumulativeProbability(int) - Method in interface org.hipparchus.distribution.IntegerDistribution
-
For a random variable X
whose values are distributed according
to this distribution, this method returns P(X <= x)
.
- g(double[], long[]) - Method in class org.hipparchus.stat.inference.GTest
-
- g(double[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- g(double, double[]) - Method in interface org.hipparchus.migration.ode.events.EventHandler
-
Deprecated.
Compute the value of the switching function.
- g(FieldODEStateAndDerivative<T>) - Method in interface org.hipparchus.ode.events.FieldODEEventHandler
-
Compute the value of the switching function.
- g(ODEStateAndDerivative) - Method in interface org.hipparchus.migration.ode.events.EventHandler
-
Deprecated.
Compute the value of the switching function.
- g(ODEStateAndDerivative) - Method in class org.hipparchus.ode.events.EventFilter
-
Compute the value of the switching function.
- g(ODEStateAndDerivative) - Method in interface org.hipparchus.ode.events.ODEEventHandler
-
Compute the value of the switching function.
- gamma(double) - Static method in class org.hipparchus.special.Gamma
-
Returns the value of Γ(x).
- Gamma - Class in org.hipparchus.special
-
This is a utility class that provides computation methods related to the
Γ (Gamma) family of functions.
- GAMMA - Static variable in class org.hipparchus.special.Gamma
-
- GammaDistribution - Class in org.hipparchus.distribution.continuous
-
Implementation of the Gamma distribution.
- GammaDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.GammaDistribution
-
Creates a new gamma distribution with specified values of the shape and
scale parameters.
- GammaDistribution(double, double, double) - Constructor for class org.hipparchus.distribution.continuous.GammaDistribution
-
Creates a Gamma distribution.
- Gaussian - Class in org.hipparchus.analysis.function
-
- Gaussian() - Constructor for class org.hipparchus.analysis.function.Gaussian
-
Normalized gaussian with zero mean and unit standard deviation.
- Gaussian(double, double) - Constructor for class org.hipparchus.analysis.function.Gaussian
-
Normalized gaussian with given mean and standard deviation.
- Gaussian(double, double, double) - Constructor for class org.hipparchus.analysis.function.Gaussian
-
Gaussian with given normalization factor, mean and standard deviation.
- Gaussian.Parametric - Class in org.hipparchus.analysis.function
-
Parametric function where the input array contains the parameters of
the Gaussian, ordered as follows:
Norm
Mean
Standard deviation
- GaussianCurveFitter - Class in org.hipparchus.fitting
-
- GaussianCurveFitter.ParameterGuesser - Class in org.hipparchus.fitting
-
Guesses the parameters
norm
,
mean
, and
sigma
of a
Gaussian.Parametric
based on the specified observed points.
- GaussianRandomGenerator - Class in org.hipparchus.random
-
This class is a gaussian normalized random generator for scalars.
- GaussianRandomGenerator(RandomGenerator) - Constructor for class org.hipparchus.random.GaussianRandomGenerator
-
Create a new generator.
- GaussIntegrator - Class in org.hipparchus.analysis.integration.gauss
-
Class that implements the Gaussian rule for
integrating
a weighted
function.
- GaussIntegrator(double[], double[]) - Constructor for class org.hipparchus.analysis.integration.gauss.GaussIntegrator
-
Creates an integrator from the given points
and weights
.
- GaussIntegrator(Pair<double[], double[]>) - Constructor for class org.hipparchus.analysis.integration.gauss.GaussIntegrator
-
Creates an integrator from the given pair of points (first element of
the pair) and weights (second element of the pair.
- GaussIntegratorFactory - Class in org.hipparchus.analysis.integration.gauss
-
- GaussIntegratorFactory() - Constructor for class org.hipparchus.analysis.integration.gauss.GaussIntegratorFactory
-
- GaussNewtonOptimizer - Class in org.hipparchus.optim.nonlinear.vector.leastsquares
-
Gauss-Newton least-squares solver.
- GaussNewtonOptimizer() - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Creates a Gauss Newton optimizer.
- GaussNewtonOptimizer(MatrixDecomposer, boolean) - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Create a Gauss Newton optimizer that uses the given matrix decomposition algorithm
to solve the normal equations.
- GaussNewtonOptimizer(GaussNewtonOptimizer.Decomposition) - Constructor for class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
- GaussNewtonOptimizer.Decomposition - Enum in org.hipparchus.optim.nonlinear.vector.leastsquares
-
- gcd(int, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Computes the greatest common divisor of the absolute value of two
numbers, using a modified version of the "binary gcd" method.
- gcd(long, long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Gets the greatest common divisor of the absolute value of two numbers,
using the "binary gcd" method which avoids division and modulo
operations.
- GCD_OVERFLOW_32_BITS - org.hipparchus.exception.LocalizedCoreFormats
-
- GCD_OVERFLOW_32_BITS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- GCD_OVERFLOW_64_BITS - org.hipparchus.exception.LocalizedCoreFormats
-
- GCD_OVERFLOW_64_BITS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- gDataSetsComparison(long[], long[]) - Method in class org.hipparchus.stat.inference.GTest
-
Computes a G (Log-Likelihood Ratio) two sample test statistic for
independence comparing frequency counts in
observed1
and observed2
.
- gDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- generate(Collection<Vector2D>) - Method in interface org.hipparchus.geometry.euclidean.twod.hull.ConvexHullGenerator2D
-
Builds the convex hull from the set of input points.
- generate(Collection<P>) - Method in interface org.hipparchus.geometry.hull.ConvexHullGenerator
-
Builds the convex hull from the set of input points.
- generateNoiseVector(RandomGenerator, double) - Static method in class org.hipparchus.samples.ClusterAlgorithmComparison
-
- GeometricDistribution - Class in org.hipparchus.distribution.discrete
-
Implementation of the geometric distribution.
- GeometricDistribution(double) - Constructor for class org.hipparchus.distribution.discrete.GeometricDistribution
-
Create a geometric distribution with the given probability of success.
- geometricMean(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the geometric mean of the entries in the input array, or
Double.NaN
if the array is empty.
- geometricMean(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the geometric mean of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray
is empty.
- GeometricMean - Class in org.hipparchus.stat.descriptive.moment
-
- GeometricMean() - Constructor for class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Create a GeometricMean instance.
- GeometricMean(GeometricMean) - Constructor for class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Copy constructor, creates a new GeometricMean
identical
to the original
.
- GeometricMean(SumOfLogs) - Constructor for class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Create a GeometricMean instance using the given SumOfLogs instance.
- GeometryExample - Class in org.hipparchus.samples.geometry
-
Simple example illustrating some parts of the geometry package.
- GeometryExample() - Constructor for class org.hipparchus.samples.geometry.GeometryExample
-
- GeometryExample.Display - Class in org.hipparchus.samples.geometry
-
- GEQ - org.hipparchus.optim.linear.Relationship
-
Greater than or equal relationship.
- get(int) - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
-
Get the stored value associated with the given key
- get(int) - Method in class org.hipparchus.util.OpenIntToFieldHashMap
-
Get the stored value associated with the given key
- getA() - Method in interface org.hipparchus.ode.nonstiff.ButcherArrayProvider
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.EulerFieldIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.EulerIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in interface org.hipparchus.ode.nonstiff.FieldButcherArrayProvider
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.GillFieldIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.GillIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.LutherFieldIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.LutherIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.MidpointFieldIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.MidpointIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA() - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
-
Get the internal weights from Butcher array (without the first empty row).
- getA(int, double) - Method in class org.hipparchus.util.ContinuedFraction
-
Access the n-th a coefficient of the continued fraction.
- getA1() - Method in class org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get the axis of the first rotation.
- getA2() - Method in class org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get the axis of the second rotation.
- getA3() - Method in class org.hipparchus.geometry.euclidean.threed.RotationOrder
-
Get the axis of the second rotation.
- getAbscissa(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Get the abscissa of a point with respect to the line.
- getAbscissa(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Get the abscissa of a point with respect to the line.
- getAbscissa(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Get the abscissa of a point with respect to the line.
- getAbsoluteAccuracy() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the absolute accuracy.
- getAbsoluteAccuracy() - Method in interface org.hipparchus.analysis.integration.UnivariateIntegrator
-
Get the absolute accuracy.
- getAbsoluteAccuracy() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the absolute accuracy of the solver.
- getAbsoluteAccuracy() - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Get the absolute accuracy of the solver.
- getAbsoluteAccuracy() - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Get the absolute accuracy of the solver.
- getAbsoluteAccuracy() - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Get the absolute accuracy.
- getAbsoluteThreshold() - Method in class org.hipparchus.optim.AbstractConvergenceChecker
-
- getAction() - Method in class org.hipparchus.ode.events.EventState.EventOccurrence
-
Get the user requested action.
- getAction() - Method in class org.hipparchus.ode.events.FieldEventState.EventOccurrence
-
Get the user requested action.
- getAdjustedRSquared() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the adjusted R-squared statistic, defined by the formula
- getAggregateN(Collection<RandomPercentile>) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns the total number of values that have been consumed by the aggregates.
- getAggregateQuantileRank(double, Collection<RandomPercentile>) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns the estimated quantile position of value in the combined dataset of the aggregates.
- getAggregateRank(double, Collection<RandomPercentile>) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Computes the estimated rank of value in the combined dataset of the aggregates.
- getAgrestiCoullInterval(int, double, double) - Static method in class org.hipparchus.stat.interval.BinomialProportion
-
Create an Agresti-Coull binomial confidence interval for the true
probability of success of an unknown binomial distribution with
the given observed number of trials, probability of success and
confidence level.
- getAllDerivatives() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get all partial derivatives.
- getAllDerivatives() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get all partial derivatives.
- getAlpha() - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
Access the first shape parameter, alpha
.
- getAlpha() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the azimuth of the vector.
- getAlpha() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the azimuth of the vector.
- getAlpha() - Method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Get the azimuthal angle \( \alpha \).
- getAngle() - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Get the angle of the rotation.
- getAngle() - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Get the angle of the rotation.
- getAngle() - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get the angle of the line.
- getAngles(RotationOrder) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
- getAngles(RotationOrder) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
- getAngles(RotationOrder, RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Get the Cardan or Euler angles corresponding to the instance.
- getAngles(RotationOrder, RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Get the Cardan or Euler angles corresponding to the instance.
- getArgument() - Method in class org.hipparchus.complex.Complex
-
Compute the argument of this complex number.
- getArgument() - Method in exception org.hipparchus.migration.exception.MathIllegalNumberException
-
Deprecated.
- getArrayRef() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Provides direct access to the internal storage array.
- getAttribute() - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Get the attribute associated with the instance.
- getAvailableLocales() - Static method in class org.hipparchus.complex.ComplexFormat
-
Get the set of locales for which complex formats are available.
- getAvailableLocales() - Static method in class org.hipparchus.fraction.BigFractionFormat
-
Get the set of locales for which complex formats are available.
- getAvailableLocales() - Static method in class org.hipparchus.fraction.FractionFormat
-
Get the set of locales for which complex formats are available.
- getAvailableLocales() - Static method in class org.hipparchus.geometry.VectorFormat
-
Get the set of locales for which point/vector formats are available.
- getAvailableLocales() - Static method in class org.hipparchus.linear.RealMatrixFormat
-
Get the set of locales for which real vectors formats are available.
- getAvailableLocales() - Static method in class org.hipparchus.linear.RealVectorFormat
-
Get the set of locales for which real vectors formats are available.
- getAxis() - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
- getAxis() - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
- getAxis(RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Get the normalized axis of the rotation.
- getAxis(RotationConvention) - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Get the normalized axis of the rotation.
- getB() - Method in interface org.hipparchus.ode.nonstiff.ButcherArrayProvider
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.EulerFieldIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.EulerIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in interface org.hipparchus.ode.nonstiff.FieldButcherArrayProvider
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.GillFieldIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.GillIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.LutherFieldIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.LutherIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.MidpointFieldIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.MidpointIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB() - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
-
Get the external weights for the high order method from Butcher array.
- getB(int, double) - Method in class org.hipparchus.util.ContinuedFraction
-
Access the n-th b coefficient of the continued fraction.
- getBarycenter() - Method in class org.hipparchus.geometry.euclidean.oned.Interval
-
Get the barycenter of the interval.
- getBarycenter() - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Get the barycenter of the instance.
- getBarycenter() - Method in interface org.hipparchus.geometry.partitioning.Region
-
Get the barycenter of the instance.
- getBarycenter() - Method in class org.hipparchus.geometry.spherical.oned.Arc
-
Get the barycenter of the arc.
- getBeta() - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
Access the second shape parameter, beta
.
- getBinCount() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Returns the number of bins.
- getBinStats() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Returns a List of
StreamingStatistics
instances containing
statistics describing the values in each of the bins.
- getBoundaryLoops() - Method in class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Get the boundary loops of the polygon.
- getBoundarySize() - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Get the size of the boundary.
- getBoundarySize() - Method in interface org.hipparchus.geometry.partitioning.Region
-
Get the size of the boundary.
- getBoundIsAllowed() - Method in exception org.hipparchus.migration.exception.NumberIsTooLargeException
-
Deprecated.
- getBoundIsAllowed() - Method in exception org.hipparchus.migration.exception.NumberIsTooSmallException
-
Deprecated.
- getBRep() - Method in class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet
-
Get the boundary representation of the instance.
- getC() - Method in interface org.hipparchus.ode.nonstiff.ButcherArrayProvider
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaFieldIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.ClassicalRungeKuttaIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.EulerFieldIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.EulerIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in interface org.hipparchus.ode.nonstiff.FieldButcherArrayProvider
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.GillFieldIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.GillIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.LutherFieldIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.LutherIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.MidpointFieldIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.MidpointIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesFieldIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getC() - Method in class org.hipparchus.ode.nonstiff.ThreeEighthesIntegrator
-
Get the time steps from Butcher array (without the first zero).
- getCapacity() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Gets the currently allocated size of the internal data structure used
for storing elements.
- getCartesian() - Method in class org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
-
Get the Cartesian coordinates.
- getCell(Point<S>, double) - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Get the cell to which a point belongs.
- getCenter() - Method in class org.hipparchus.clustering.CentroidCluster
-
Get the point chosen to be the center of this cluster.
- getCenter() - Method in class org.hipparchus.geometry.enclosing.EnclosingBall
-
Get the center of the ball.
- getCenters() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of the centers array.
- getCheck() - Method in class org.hipparchus.linear.ConjugateGradient
-
Returns true
if positive-definiteness should be checked for both
matrix and preconditioner.
- getCheck() - Method in class org.hipparchus.linear.SymmLQ
-
Returns true
if symmetry of the matrix, and symmetry as well as
positive definiteness of the preconditioner should be checked.
- getChiSquare() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
-
Get the sum of the squares of the residuals.
- getChiSquare() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
-
Get the sum of the squares of the residuals.
- getCircle() - Method in class org.hipparchus.geometry.spherical.twod.Edge
-
Get the circle supporting this edge.
- getClopperPearsonInterval(int, double, double) - Static method in class org.hipparchus.stat.interval.BinomialProportion
-
Create a Clopper-Pearson binomial confidence interval for the true
probability of success of an unknown binomial distribution with
the given observed number of trials, probability of success and
confidence level.
- getCloseCuts(Point<S>, double) - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Get the cells whose cut sub-hyperplanes are close to the point.
- getClusterer() - Method in class org.hipparchus.clustering.MultiKMeansPlusPlusClusterer
-
Returns the embedded k-means clusterer used by this instance.
- getClusterEvaluator() - Method in class org.hipparchus.clustering.MultiKMeansPlusPlusClusterer
-
- getClusters() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
- getCoefficients() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of the coefficients array.
- getCoefficients() - Method in class org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
- getCoefficients() - Method in class org.hipparchus.optim.linear.LinearConstraint
-
Gets the coefficients of the constraint (left hand side).
- getCoefficients() - Method in class org.hipparchus.optim.linear.LinearObjectiveFunction
-
Gets the coefficients of the linear equation being optimized.
- getColumn() - Method in exception org.hipparchus.migration.linear.NonPositiveDefiniteMatrixException
-
Deprecated.
- getColumn() - Method in exception org.hipparchus.migration.linear.NonSymmetricMatrixException
-
Deprecated.
- getColumn(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get the entries in column number col
as an array.
- getColumn(int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Get the entries at the given column index as an array.
- getColumn(int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Get the entries in column number col
as an array.
- getColumn(int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Get the entries at the given column index as an array.
- getColumn(int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Get the entries in column number col
as an array.
- getColumn(int) - Method in interface org.hipparchus.linear.RealMatrix
-
Get the entries at the given column index as an array.
- getColumnDimension() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in interface org.hipparchus.linear.AnyMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnDimension() - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in class org.hipparchus.linear.JacobiPreconditioner
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Returns the number of columns of this matrix.
- getColumnDimension() - Method in interface org.hipparchus.linear.RealLinearOperator
-
Returns the dimension of the domain of this operator.
- getColumnDimension() - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Returns the number of columns in the matrix.
- getColumnMatrix(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get the entries in column number column
as a column matrix.
- getColumnMatrix(int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Get the entries at the given column index as a column matrix.
- getColumnMatrix(int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Get the entries in column number column
as a column matrix.
- getColumnMatrix(int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Get the entries at the given column index as a column matrix.
- getColumnMatrix(int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Get the entries in column number column
as a column matrix.
- getColumnMatrix(int) - Method in interface org.hipparchus.linear.RealMatrix
-
Get the entries at the given column index as a column matrix.
- getColumnSeparator() - Method in class org.hipparchus.linear.RealMatrixFormat
-
Get the format separator between components.
- getColumnVector(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the entries in column number column
as a vector.
- getColumnVector(int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Get the entries at the given column index as a vector.
- getColumnVector(int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the entries in column number column
as a vector.
- getColumnVector(int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Get the entries at the given column index as a vector.
- getColumnVector(int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the entries in column number column
as a vector.
- getColumnVector(int) - Method in interface org.hipparchus.linear.RealMatrix
-
Get the entries at the given column index as a vector.
- getCommand() - Method in class org.hipparchus.filtering.kalman.linear.LinearEvolution
-
Get the command uk-1.
- getCompiler() - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
Get the compiler for the current dimensions.
- getCompiler() - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
Get the compiler for the current dimensions.
- getCompiler(int, int) - Static method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Get the compiler for number of free parameters and order.
- getComplement(Region<S>) - Method in class org.hipparchus.geometry.partitioning.RegionFactory
-
Get the complement of the region (exchanged interior/exterior).
- getCompleteDerivative() - Method in class org.hipparchus.ode.FieldODEStateAndDerivative
-
Get complete derivative at time.
- getCompleteDerivative() - Method in class org.hipparchus.ode.ODEStateAndDerivative
-
Get complete derivative at time.
- getCompleteState() - Method in class org.hipparchus.ode.FieldODEState
-
Get complete state at time.
- getCompleteState() - Method in class org.hipparchus.ode.ODEState
-
Get complete state at time.
- getCompleteStateDimension() - Method in class org.hipparchus.ode.FieldODEState
-
Return the dimension of the complete set of equations.
- getCompleteStateDimension() - Method in class org.hipparchus.ode.ODEState
-
Return the dimension of the complete set of equations.
- getComponent(int) - Method in class org.hipparchus.util.FieldTuple
-
Get one component of the tuple.
- getComponent(int) - Method in class org.hipparchus.util.Tuple
-
Get one component of the tuple.
- getComponents() - Method in class org.hipparchus.distribution.multivariate.MixtureMultivariateRealDistribution
-
Gets the distributions that make up the mixture model.
- getComponents() - Method in class org.hipparchus.util.FieldTuple
-
Get all components of the tuple.
- getComponents() - Method in class org.hipparchus.util.Tuple
-
Get all components of the tuple.
- getConditionNumber() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Return the condition number of the matrix.
- getConfidenceLevel() - Method in class org.hipparchus.stat.interval.ConfidenceInterval
-
- getConjugate() - Method in class org.hipparchus.complex.Quaternion
-
Returns the conjugate quaternion of the instance.
- getConstantTerm() - Method in class org.hipparchus.optim.linear.LinearObjectiveFunction
-
Gets the constant of the linear equation being optimized.
- getConstraints() - Method in class org.hipparchus.optim.linear.LinearConstraintSet
-
Gets the set of linear constraints.
- getConstraints() - Method in class org.hipparchus.optim.linear.LinearOptimizer
-
- getContractionCriterion() - Method in class org.hipparchus.util.ResizableDoubleArray
-
The contraction criterion defines when the internal array will contract
to store only the number of elements in the element array.
- getControlMatrix() - Method in class org.hipparchus.filtering.kalman.linear.LinearEvolution
-
Get the control matrix Bk-1.
- getConvergence() - Method in class org.hipparchus.ode.events.EventState
-
Get the convergence threshold for event localization.
- getConvergence() - Method in class org.hipparchus.ode.events.FieldEventState
-
Get the convergence threshold for event localization.
- getConvergenceChecker() - Method in class org.hipparchus.optim.AbstractOptimizationProblem
-
Gets the convergence checker.
- getConvergenceChecker() - Method in class org.hipparchus.optim.BaseOptimizer
-
Gets the convergence checker.
- getConvergenceChecker() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
-
Gets the convergence checker.
- getConvergenceChecker() - Method in interface org.hipparchus.optim.OptimizationProblem
-
Gets the convergence checker.
- getCorrected() - Method in class org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Get the corrected state.
- getCorrected() - Method in interface org.hipparchus.filtering.kalman.KalmanFilter
-
Get the current corrected state.
- getCorrelationMatrix() - Method in class org.hipparchus.stat.correlation.KendallsCorrelation
-
Returns the correlation matrix.
- getCorrelationMatrix() - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Returns the correlation matrix.
- getCorrelationMatrix() - Method in class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Calculate the Spearman Rank Correlation Matrix.
- getCorrelationPValues() - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Returns a matrix of p-values associated with the (two-sided) null
hypothesis that the corresponding correlation coefficient is zero.
- getCorrelationStandardErrors() - Method in class org.hipparchus.stat.correlation.PearsonsCorrelation
-
Returns a matrix of standard errors associated with the estimates
in the correlation matrix.
getCorrelationStandardErrors().getEntry(i,j)
is the standard
error associated with getCorrelationMatrix.getEntry(i,j)
- getCost() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
-
Get the cost.
- getCost() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
-
Get the cost.
- getCostRelativeTolerance() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Gets the value of a tuning parameter.
- getCount() - Method in class org.hipparchus.util.Incrementor
-
Gets the current count.
- getCount() - Method in class org.hipparchus.util.MultidimensionalCounter.Iterator
-
Get the current unidimensional counter slot.
- getCount(int) - Method in class org.hipparchus.stat.LongFrequency
-
Returns the number of values equal to v.
- getCount(int) - Method in class org.hipparchus.util.MultidimensionalCounter.Iterator
-
Get the current count in the selected dimension.
- getCount(int...) - Method in class org.hipparchus.util.MultidimensionalCounter
-
Convert to unidimensional counter.
- getCount(T) - Method in class org.hipparchus.stat.Frequency
-
Returns the number of values equal to v.
- getCounts() - Method in class org.hipparchus.util.MultidimensionalCounter.Iterator
-
Get the current multidimensional counter slots.
- getCounts(int) - Method in class org.hipparchus.util.MultidimensionalCounter
-
Convert to multidimensional counter.
- getCovariance() - Method in interface org.hipparchus.filtering.kalman.Measurement
-
Get the measurement covariance.
- getCovariance() - Method in class org.hipparchus.filtering.kalman.ProcessEstimate
-
Get the state covariance.
- getCovariance() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns the covariance of the available values.
- getCovariance() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns the covariance of the available values.
- getCovariance(double) - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Returns the n × n covariance matrix.
- getCovariance(int, int) - Method in class org.hipparchus.stat.correlation.StorelessCovariance
-
Get the covariance for an individual element of the covariance matrix.
- getCovarianceMatrix() - Method in class org.hipparchus.stat.correlation.Covariance
-
Returns the covariance matrix
- getCovarianceMatrix() - Method in class org.hipparchus.stat.correlation.StorelessCovariance
-
Returns the covariance matrix
- getCovarianceOfParameters(int, int) - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the covariance between regression parameters i and j.
- getCovariances() - Method in class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Gets the covariance matrix.
- getCovariances(double) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
-
Get the covariance matrix of the optimized parameters.
- getCovariances(double) - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
-
Get the covariance matrix of the optimized parameters.
- getCumFreq(int) - Method in class org.hipparchus.stat.LongFrequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumFreq(T) - Method in class org.hipparchus.stat.Frequency
-
Returns the cumulative frequency of values less than or equal to v.
- getCumPct(int) - Method in class org.hipparchus.stat.LongFrequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCumPct(T) - Method in class org.hipparchus.stat.Frequency
-
Returns the cumulative percentage of values less than or equal to v
(as a proportion between 0 and 1).
- getCurrentSignedStepsize() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get the current signed value of the integration stepsize.
- getCurrentSignedStepsize() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get the current signed value of the integration stepsize.
- getCurrentSignedStepsize() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Get the current signed value of the integration stepsize.
- getCurrentSignedStepsize() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Get the current signed value of the integration stepsize.
- getCurrentState() - Method in class org.hipparchus.filtering.kalman.extended.NonLinearEvolution
-
Get current state.
- getCurrentState() - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Get the state at current grid point time.
- getCurrentState() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Get the state at current grid point time.
- getCurrentState() - Method in interface org.hipparchus.ode.sampling.FieldODEStateInterpolator
-
Get the state at current grid point time.
- getCurrentState() - Method in interface org.hipparchus.ode.sampling.ODEStateInterpolator
-
Get the state at current grid point time.
- getCurrentStepStart() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Deprecated.
- getCurrentStepStart() - Method in interface org.hipparchus.ode.ODEIntegrator
-
- getCurrentTime() - Method in class org.hipparchus.filtering.kalman.extended.NonLinearEvolution
-
Get current time.
- getCurrentTime() - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
- getCut() - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Get the cut sub-hyperplane.
- getD() - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Getter D.
- getD() - Method in class org.hipparchus.linear.EigenDecomposition
-
Gets the block diagonal matrix D of the decomposition.
- getData() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in interface org.hipparchus.linear.RealMatrix
-
Returns matrix entries as a two-dimensional array.
- getData() - Method in class org.hipparchus.stat.correlation.StorelessCovariance
-
Return the covariance matrix as two-dimensional array.
- getData() - Method in class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Get a copy of the stored data array.
- getDataPoints() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
- getDataRef() - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Get a reference to the underlying data array.
- getDataRef() - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Get a reference to the underlying data array.
- getDataRef() - Method in class org.hipparchus.linear.ArrayFieldVector
-
Returns a reference to the underlying data array.
- getDataRef() - Method in class org.hipparchus.linear.ArrayRealVector
-
Get a reference to the underlying data array.
- getDataRef() - Method in class org.hipparchus.linear.DiagonalMatrix
-
Gets a reference to the underlying data array.
- getDataRef() - Method in class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Get a reference to the stored data array.
- getDecimalDigits() - Method in class org.hipparchus.dfp.DfpDec
-
Get the number of decimal digits this class is going to represent.
- getDecomposer() - Method in enum org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer.Decomposition
-
Deprecated.
Get the equivalent matrix decomposer.
- getDecomposer() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Get the matrix decomposition algorithm.
- getDecomposition() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
- getDefaultNumberFormat() - Static method in class org.hipparchus.fraction.FractionFormat
-
Create a default number format.
- getDefaultNumberFormat() - Static method in class org.hipparchus.util.CompositeFormat
-
Create a default number format.
- getDefaultNumberFormat(Locale) - Static method in class org.hipparchus.util.CompositeFormat
-
Create a default number format.
- getDegreesOfFreedom() - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Access the number of degrees of freedom.
- getDegreesOfFreedom() - Method in class org.hipparchus.distribution.continuous.TDistribution
-
Access the degrees of freedom.
- getDelta() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the elevation of the vector.
- getDelta() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the elevation of the vector.
- getDenominator() - Method in class org.hipparchus.fraction.BigFraction
-
Access the denominator as a BigInteger
.
- getDenominator() - Method in class org.hipparchus.fraction.Fraction
-
Access the denominator.
- getDenominatorAsInt() - Method in class org.hipparchus.fraction.BigFraction
-
Access the denominator as a int
.
- getDenominatorAsLong() - Method in class org.hipparchus.fraction.BigFraction
-
Access the denominator as a long
.
- getDenominatorDegreesOfFreedom() - Method in class org.hipparchus.distribution.continuous.FDistribution
-
Access the denominator degrees of freedom.
- getDerivative(int) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the derivative with respect to a particular index variable.
- getDerivativeField() - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
- getDerivativeField() - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
- getDeterminant() - Method in class org.hipparchus.linear.CholeskyDecomposition
-
Return the determinant of the matrix
- getDeterminant() - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Computes the determinant.
- getDeterminant() - Method in class org.hipparchus.linear.EigenDecomposition
-
Computes the determinant of the matrix.
- getDeterminant() - Method in class org.hipparchus.linear.FieldLUDecomposition
-
Return the determinant of the matrix.
- getDeterminant() - Method in class org.hipparchus.linear.LUDecomposition
-
Return the determinant of the matrix
- getDiagonalOfHatMatrix(double[]) - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Gets the diagonal of the Hat matrix also known as the leverage matrix.
- getDimension() - Method in class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Get the space dimensionality.
- getDimension() - Method in class org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
-
Gets the number of random variables of the distribution.
- getDimension() - Method in interface org.hipparchus.distribution.MultivariateRealDistribution
-
Gets the number of random variables of the distribution.
- getDimension() - Method in class org.hipparchus.geometry.euclidean.oned.Euclidean1D
-
Get the dimension of the space.
- getDimension() - Method in class org.hipparchus.geometry.euclidean.threed.Euclidean3D
-
Get the dimension of the space.
- getDimension() - Method in class org.hipparchus.geometry.euclidean.twod.Euclidean2D
-
Get the dimension of the space.
- getDimension() - Method in interface org.hipparchus.geometry.Space
-
Get the dimension of the space.
- getDimension() - Method in class org.hipparchus.geometry.spherical.oned.Sphere1D
-
Get the dimension of the space.
- getDimension() - Method in class org.hipparchus.geometry.spherical.twod.Sphere2D
-
Get the dimension of the space.
- getDimension() - Method in class org.hipparchus.linear.ArrayFieldVector
-
Returns the size of the vector.
- getDimension() - Method in class org.hipparchus.linear.ArrayRealVector
-
Returns the size of the vector.
- getDimension() - Method in interface org.hipparchus.linear.FieldVector
-
Returns the size of the vector.
- getDimension() - Method in class org.hipparchus.linear.OpenMapRealVector
-
Returns the size of the vector.
- getDimension() - Method in class org.hipparchus.linear.RealVector
-
Returns the size of the vector.
- getDimension() - Method in class org.hipparchus.linear.SparseFieldVector
-
Returns the size of the vector.
- getDimension() - Method in exception org.hipparchus.migration.exception.DimensionMismatchException
-
Deprecated.
- getDimension() - Method in interface org.hipparchus.ode.FieldOrdinaryDifferentialEquation
-
Get the dimension of the problem.
- getDimension() - Method in interface org.hipparchus.ode.FieldSecondaryODE
-
Get the dimension of the secondary state parameters.
- getDimension() - Method in class org.hipparchus.ode.FirstOrderConverter
-
Get the dimension of the problem.
- getDimension() - Method in interface org.hipparchus.ode.OrdinaryDifferentialEquation
-
Get the dimension of the problem.
- getDimension() - Method in interface org.hipparchus.ode.SecondaryODE
-
Get the dimension of the secondary state parameters.
- getDimension() - Method in interface org.hipparchus.ode.SecondOrderODE
-
Get the dimension of the problem.
- getDimension() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Get simplex dimension.
- getDimension() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns the dimension of the data
- getDimension() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns the dimension of the data
- getDimension() - Method in interface org.hipparchus.stat.descriptive.StorelessMultivariateStatistic
-
Returns the dimension of the statistic.
- getDimension() - Method in class org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
-
Returns the dimension of the statistic.
- getDimension() - Method in class org.hipparchus.util.FieldTuple
-
Get the dimension of the tuple.
- getDimension() - Method in class org.hipparchus.util.MultidimensionalCounter
-
Get the number of dimensions of the multidimensional counter.
- getDimension() - Method in class org.hipparchus.util.Tuple
-
Get the dimension of the tuple.
- getDirection() - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Get the normalized direction vector.
- getDirection() - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Get the normalized direction vector.
- getDirection() - Method in exception org.hipparchus.migration.exception.NonMonotonicSequenceException
-
Deprecated.
- getDistance(OpenMapRealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Optimized method to compute distance.
- getDistance(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Distance between two vectors.
- getDistance(RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Distance between two vectors.
- getDistance(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Distance between two vectors.
- getDistanceMeasure() - Method in class org.hipparchus.clustering.Clusterer
-
- getE() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant e.
- getEigenvalues() - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Getter of the eigen values.
- getEigenvector(int) - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Getter of the eigen vectors.
- getEigenvector(int) - Method in class org.hipparchus.linear.EigenDecomposition
-
Gets a copy of the ith eigenvector of the original matrix.
- getElement(int) - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the element at the specified index
- getElement(int) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Returns the element at the specified index.
- getElements() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Returns a double array containing the elements of this ResizableArray.
- getEmptyClusterStrategy() - Method in class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
- getEnclosingCap() - Method in class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Get a spherical cap enclosing the polygon.
- getEnd() - Method in class org.hipparchus.geometry.euclidean.threed.Segment
-
Get the end point of the segment.
- getEnd() - Method in class org.hipparchus.geometry.euclidean.twod.Segment
-
Get the end point of the segment.
- getEnd() - Method in class org.hipparchus.geometry.spherical.twod.Edge
-
Get end vertex.
- getEntry(int) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Returns the entry in the specified index.
- getEntry(int) - Method in class org.hipparchus.linear.ArrayRealVector
-
Return the entry at the specified index.
- getEntry(int) - Method in interface org.hipparchus.linear.FieldVector
-
Returns the entry in the specified index.
- getEntry(int) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Return the entry at the specified index.
- getEntry(int) - Method in class org.hipparchus.linear.RealVector
-
Return the entry at the specified index.
- getEntry(int) - Method in class org.hipparchus.linear.SparseFieldVector
-
Returns the entry in the specified index.
- getEntry(int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Get the entry in the specified row and column.
- getEntry(int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Get the entry in the specified row and column.
- getEntry(int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Get the entry in the specified row and column.
- getEntry(int, int) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Get the entry in the specified row and column.
- getEntry(int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the entry in the specified row and column.
- getEntry(int, int) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Get the entry in the specified row and column.
- getEntry(int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Get the entry in the specified row and column.
- getEntry(int, int) - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Returns the entry in the specified row and column.
- getEps() - Method in class org.hipparchus.clustering.DBSCANClusterer
-
Returns the maximum radius of the neighborhood to be considered.
- getEpsilon() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Returns the convergence criteria used by this instance.
- getEquations() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get the differential equations to integrate.
- getEquations() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get the differential equations to integrate.
- getErrorSumSquares() - Method in class org.hipparchus.stat.regression.RegressionResults
-
- getESplit() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant e split in two pieces.
- getEstimationType() - Method in class org.hipparchus.stat.descriptive.rank.Median
-
Get the estimation
type
used for computation.
- getEstimationType() - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Get the estimation
type
used for computation.
- getEvaluationCounter() - Method in class org.hipparchus.optim.AbstractOptimizationProblem
-
Get a independent Incrementor that counts up to the maximum number of evaluations
and then throws an exception.
- getEvaluationCounter() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
-
Get a independent Incrementor that counts up to the maximum number of evaluations
and then throws an exception.
- getEvaluationCounter() - Method in interface org.hipparchus.optim.OptimizationProblem
-
Get a independent Incrementor that counts up to the maximum number of evaluations
and then throws an exception.
- getEvaluations() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the number of function evaluations of the last run of the integrator.
- getEvaluations() - Method in interface org.hipparchus.analysis.integration.UnivariateIntegrator
-
Get the number of function evaluations of the last run of the integrator.
- getEvaluations() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Get the number of evaluations of the objective function.
- getEvaluations() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get the number of evaluations of the differential equations function.
- getEvaluations() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get the number of evaluations of the differential equations function.
- getEvaluations() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Get the number of evaluations of the differential equations function.
- getEvaluations() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Get the number of evaluations of the differential equations function.
- getEvaluations() - Method in class org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
-
Gets the number of evaluations of the objective function.
- getEvaluations() - Method in class org.hipparchus.optim.BaseOptimizer
-
Gets the number of evaluations of the objective function.
- getEvaluations() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresOptimizer.Optimum
-
Get the number of times the model was evaluated in order to produce this
optimum.
- getEvaluations() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
- getEvaluations() - Method in class org.hipparchus.optim.univariate.MultiStartUnivariateOptimizer
-
Gets the number of evaluations of the objective function.
- getEvaluationsCounter() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get the evaluations counter.
- getEvaluationsCounter() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get the evaluations counter.
- getEventHandler() - Method in class org.hipparchus.ode.events.EventState
-
Get the underlying event handler.
- getEventHandler() - Method in class org.hipparchus.ode.events.FieldEventState
-
Get the underlying event handler.
- getEventHandlers() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get all the event handlers that have been added to the integrator.
- getEventHandlers() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get all the event handlers that have been added to the integrator.
- getEventHandlers() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Get all the event handlers that have been added to the integrator.
- getEventHandlers() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Get all the event handlers that have been added to the integrator.
- getEventTime() - Method in class org.hipparchus.ode.events.EventState
-
Get the occurrence time of the event triggered in the current step.
- getEventTime() - Method in class org.hipparchus.ode.events.FieldEventState
-
Get the occurrence time of the event triggered in the current step.
- getEvolution(double, RealVector, T) - Method in interface org.hipparchus.filtering.kalman.extended.NonLinearProcess
-
Get the state evolution between two times.
- getEvolution(T) - Method in interface org.hipparchus.filtering.kalman.linear.LinearProcess
-
Get the state evolution between two times.
- getExpansionFactor() - Method in class org.hipparchus.util.ResizableDoubleArray
-
The expansion factor controls the size of a new array when an array
needs to be expanded.
- getExpansionMode() - Method in class org.hipparchus.util.ResizableDoubleArray
-
The expansion mode determines whether the internal storage
array grows additively or multiplicatively when it is expanded.
- getExpectedColumnDimension() - Method in exception org.hipparchus.migration.linear.MatrixDimensionMismatchException
-
Deprecated.
- getExpectedDimension(int) - Method in exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.
- getExpectedDimensions() - Method in exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.
- getExpectedRowDimension() - Method in exception org.hipparchus.migration.linear.MatrixDimensionMismatchException
-
Deprecated.
- getExponent() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Return the exponent of the instance value, removing the bias.
- getExponent() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Return the exponent of the instance value, removing the bias.
- getExponent() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
Get the exponent characterizing the distribution.
- getExponent(double) - Static method in class org.hipparchus.util.FastMath
-
Return the exponent of a double number, removing the bias.
- getExponent(float) - Static method in class org.hipparchus.util.FastMath
-
Return the exponent of a float number, removing the bias.
- getFacets() - Method in class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet.BRep
-
Get the extracted facets.
- getFactory() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the factory that built the instance.
- getFactory() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the factory that built the instance.
- getFHi() - Method in exception org.hipparchus.migration.exception.NoBracketingException
-
Deprecated.
Get the value at the higher end of the interval.
- getFHi() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
- getField() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.complex.Complex
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.dfp.Dfp
-
- getField() - Method in interface org.hipparchus.FieldElement
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.fraction.BigFraction
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.fraction.Fraction
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get the type of field elements of the matrix.
- getField() - Method in class org.hipparchus.linear.ArrayFieldVector
-
Get the type of field elements of the vector.
- getField() - Method in interface org.hipparchus.linear.FieldMatrix
-
Get the type of field elements of the matrix.
- getField() - Method in interface org.hipparchus.linear.FieldVector
-
Get the type of field elements of the vector.
- getField() - Method in class org.hipparchus.linear.SparseFieldVector
-
Get the type of field elements of the vector.
- getField() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get the field to which state vector elements belong.
- getField() - Method in class org.hipparchus.util.BigReal
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.util.Decimal64
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.util.FieldTuple
-
Get the
Field
to which the instance belongs.
- getField() - Method in class org.hipparchus.util.Tuple
-
Get the
Field
to which the instance belongs.
- getFinalTime() - Method in class org.hipparchus.ode.DenseOutputModel
-
Get the final integration time.
- getFinalTime() - Method in class org.hipparchus.ode.FieldDenseOutputModel
-
Get the final integration time.
- getFirst() - Method in class org.hipparchus.util.Pair
-
Get the first element of the pair.
- getFittedModel() - Method in class org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
Gets the fitted model.
- getFLo() - Method in exception org.hipparchus.migration.exception.NoBracketingException
-
Deprecated.
Get the value at the lower end of the interval.
- getFLo() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
- getFMid() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
- getFormat() - Method in class org.hipparchus.geometry.VectorFormat
-
Get the components format.
- getFormat() - Method in class org.hipparchus.linear.RealMatrixFormat
-
Get the components format.
- getFormat() - Method in class org.hipparchus.linear.RealVectorFormat
-
Get the components format.
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the number of free parameters.
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Get the number of free parameters.
- getFreeParameters() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the number of free parameters.
- getFrobeniusNorm() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
- getFrobeniusNorm() - Method in class org.hipparchus.linear.BlockRealMatrix
-
- getFrobeniusNorm() - Method in interface org.hipparchus.linear.RealMatrix
-
- getFunction() - Method in class org.hipparchus.optim.linear.LinearOptimizer
-
- getFunctionValueAccuracy() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the function value accuracy of the solver.
- getFunctionValueAccuracy() - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Get the function value accuracy of the solver.
- getFunctionValueAccuracy() - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Get the function value accuracy of the solver.
- getFunctionValueAccuracy() - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Get the function accuracy.
- getFuzziness() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Returns the fuzziness factor used by this instance.
- getGenerator() - Method in class org.hipparchus.random.CorrelatedRandomVectorGenerator
-
Get the underlying normalized components generator.
- getGeneratorUpperBounds() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Returns a fresh copy of the array of upper bounds of the subintervals
of [0,1] used in generating data from the empirical distribution.
- getGeometricMean() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the geometric mean of the available values.
- getGeometricMean() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns an array whose ith entry is the
geometric mean of the ith entries of the arrays
that correspond to each multivariate sample
- getGeometricMean() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
geometric mean of the ith entries of the arrays
that correspond to each multivariate sample
- getGeometricMean() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the geometric mean of the values that have been added.
- getGlobalCurrentState() - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Get the current global grid point state.
- getGlobalCurrentState() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Get the current global grid point state.
- getGlobalPreviousState() - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Get the previous global grid point state.
- getGlobalPreviousState() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Get the previous global grid point state.
- getGoalType() - Method in class org.hipparchus.optim.nonlinear.scalar.MultivariateOptimizer
-
- getGoalType() - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
- getH() - Method in class org.hipparchus.linear.FieldQRDecomposition
-
Returns the Householder reflector vectors.
- getH() - Method in class org.hipparchus.linear.QRDecomposition
-
Returns the Householder reflector vectors.
- getHi() - Method in exception org.hipparchus.migration.exception.NoBracketingException
-
Deprecated.
Get the higher end of the interval.
- getHi() - Method in exception org.hipparchus.migration.exception.OutOfRangeException
-
Deprecated.
- getHi() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
- getHP() - Method in class org.hipparchus.ode.ParameterConfiguration
-
Get parameter step.
- getHyperplane() - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Get the underlying hyperplane.
- getHyperplane() - Method in interface org.hipparchus.geometry.partitioning.SubHyperplane
-
Get the underlying hyperplane.
- getIdentity(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Get identity rotation.
- getIEEEFlags() - Method in class org.hipparchus.dfp.DfpField
-
Get the IEEE 854 status flags.
- getImagEigenvalue(int) - Method in class org.hipparchus.linear.EigenDecomposition
-
Gets the imaginary part of the ith eigenvalue of the original
matrix.
- getImagEigenvalues() - Method in class org.hipparchus.linear.EigenDecomposition
-
Gets a copy of the imaginary parts of the eigenvalues of the original
matrix.
- getImaginary() - Method in class org.hipparchus.complex.Complex
-
Access the imaginary part.
- getImaginary(int) - Method in class org.hipparchus.complex.RootsOfUnity
-
Get the imaginary part of the k
-th n
-th root of unity.
- getImaginaryCharacter() - Method in class org.hipparchus.complex.ComplexFormat
-
Access the imaginaryCharacter.
- getImaginaryFormat() - Method in class org.hipparchus.complex.ComplexFormat
-
Access the imaginaryFormat.
- getImproperInstance() - Static method in class org.hipparchus.fraction.BigFractionFormat
-
Returns the default complex format for the current locale.
- getImproperInstance() - Static method in class org.hipparchus.fraction.FractionFormat
-
Returns the default complex format for the current locale.
- getImproperInstance(Locale) - Static method in class org.hipparchus.fraction.BigFractionFormat
-
Returns the default complex format for the given locale.
- getImproperInstance(Locale) - Static method in class org.hipparchus.fraction.FractionFormat
-
Returns the default complex format for the given locale.
- getIncoming() - Method in class org.hipparchus.geometry.spherical.twod.Vertex
-
Get incoming edge.
- getIndex() - Method in class org.hipparchus.linear.OpenMapRealVector.OpenMapEntry
-
Get the index of the entry.
- getIndex() - Method in class org.hipparchus.linear.RealVector.Entry
-
Get the index of the entry.
- getIndex() - Method in exception org.hipparchus.migration.exception.NonMonotonicSequenceException
-
Deprecated.
Get the index of the wrong value.
- getIndexM1(int) - Method in class org.hipparchus.random.AbstractWell.IndexTable
-
Returns index + M1 modulo the table size.
- getIndexM2(int) - Method in class org.hipparchus.random.AbstractWell.IndexTable
-
Returns index + M2 modulo the table size.
- getIndexM3(int) - Method in class org.hipparchus.random.AbstractWell.IndexTable
-
Returns index + M3 modulo the table size.
- getIndexPred(int) - Method in class org.hipparchus.random.AbstractWell.IndexTable
-
Returns the predecessor of the given index modulo the table size.
- getIndexPred2(int) - Method in class org.hipparchus.random.AbstractWell.IndexTable
-
Returns the second predecessor of the given index modulo the table size.
- getInf() - Method in class org.hipparchus.geometry.euclidean.oned.Interval
-
Get the lower bound of the interval.
- getInf() - Method in class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Get the lowest value belonging to the instance.
- getInf() - Method in class org.hipparchus.geometry.spherical.oned.Arc
-
Get the lower angular bound of the arc.
- getInitialGuess() - Method in class org.hipparchus.optim.InitialGuess
-
Gets the initial guess.
- getInitialStepBoundFactor() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Gets the value of a tuning parameter.
- getInitialTime() - Method in class org.hipparchus.ode.DenseOutputModel
-
Get the initial integration time.
- getInitialTime() - Method in class org.hipparchus.ode.FieldDenseOutputModel
-
Get the initial integration time.
- getInnovation(T, NonLinearEvolution, RealMatrix) - Method in interface org.hipparchus.filtering.kalman.extended.NonLinearProcess
-
Get the innovation brought by a measurement.
- getInsideArc(Circle) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the arc of the instance that lies inside the other circle.
- getInstance() - Static method in class org.hipparchus.complex.ComplexField
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.complex.ComplexFormat
-
Returns the default complex format for the current locale.
- getInstance() - Static method in class org.hipparchus.fraction.BigFractionField
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.fraction.FractionField
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.geometry.euclidean.oned.Euclidean1D
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Returns the default 1D vector format for the current locale.
- getInstance() - Static method in class org.hipparchus.geometry.euclidean.threed.Euclidean3D
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Returns the default 3D vector format for the current locale.
- getInstance() - Static method in class org.hipparchus.geometry.euclidean.twod.Euclidean2D
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Returns the default 2D vector format for the current locale.
- getInstance() - Static method in class org.hipparchus.geometry.spherical.oned.Sphere1D
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.geometry.spherical.twod.Sphere2D
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.linear.RealMatrixFormat
-
Returns the default real vector format for the current locale.
- getInstance() - Static method in class org.hipparchus.linear.RealVectorFormat
-
Returns the default real vector format for the current locale.
- getInstance() - Static method in class org.hipparchus.migration.ode.sampling.DummyStepHandler
-
Deprecated.
Get the only instance.
- getInstance() - Static method in class org.hipparchus.util.BigRealField
-
Get the unique instance.
- getInstance() - Static method in class org.hipparchus.util.Decimal64Field
-
Returns the unique instance of this class.
- getInstance(int) - Static method in class org.hipparchus.ode.nonstiff.AdamsNordsieckTransformer
-
Get the Nordsieck transformer for a given number of steps.
- getInstance(String, Locale) - Static method in class org.hipparchus.complex.ComplexFormat
-
Returns the default complex format for the given locale.
- getInstance(Locale) - Static method in class org.hipparchus.complex.ComplexFormat
-
Returns the default complex format for the given locale.
- getInstance(Locale) - Static method in class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Returns the default 1D vector format for the given locale.
- getInstance(Locale) - Static method in class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Returns the default 3D vector format for the given locale.
- getInstance(Locale) - Static method in class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Returns the default 2D vector format for the given locale.
- getInstance(Locale) - Static method in class org.hipparchus.linear.RealMatrixFormat
-
Returns the default real vector format for the given locale.
- getInstance(Locale) - Static method in class org.hipparchus.linear.RealVectorFormat
-
Returns the default real vector format for the given locale.
- getInstance(Field<T>, int) - Static method in class org.hipparchus.ode.nonstiff.AdamsNordsieckFieldTransformer
-
Get the Nordsieck transformer for a given field and number of steps.
- getIntercept() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
- getInterceptStdErr() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
- getInterpolatedDerivatives() - Method in class org.hipparchus.migration.ode.ContinuousOutputModel
-
Deprecated.
Get the derivatives of the state vector of the interpolated point.
- getInterpolatedDerivatives() - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
- getInterpolatedSecondaryDerivatives(int) - Method in class org.hipparchus.migration.ode.ContinuousOutputModel
-
Deprecated.
Get the interpolated secondary derivatives corresponding to the secondary equations.
- getInterpolatedSecondaryDerivatives(int) - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
- getInterpolatedSecondaryState(int) - Method in class org.hipparchus.migration.ode.ContinuousOutputModel
-
Deprecated.
Get the interpolated secondary state corresponding to the secondary equations.
- getInterpolatedSecondaryState(int) - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
- getInterpolatedState() - Method in class org.hipparchus.migration.ode.ContinuousOutputModel
-
Deprecated.
Get the state vector of the interpolated point.
- getInterpolatedState() - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
- getInterpolatedState(double) - Method in class org.hipparchus.ode.DenseOutputModel
-
Get the state at interpolated time.
- getInterpolatedState(double) - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Get the state at interpolated time.
- getInterpolatedState(double) - Method in interface org.hipparchus.ode.sampling.ODEStateInterpolator
-
Get the state at interpolated time.
- getInterpolatedState(T) - Method in class org.hipparchus.ode.FieldDenseOutputModel
-
Get the state at interpolated time.
- getInterpolatedState(T) - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Get the state at interpolated time.
- getInterpolatedState(T) - Method in interface org.hipparchus.ode.sampling.FieldODEStateInterpolator
-
Get the state at interpolated time.
- getInterpolatedTime() - Method in class org.hipparchus.migration.ode.ContinuousOutputModel
-
Deprecated.
Get the time of the interpolated point.
- getInterpolatedTime() - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
- getInterpolatingPoints() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the interpolating points array.
- getInterpolatingValues() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Returns a copy of the interpolating values array.
- getInverse() - Method in class org.hipparchus.complex.Quaternion
-
Returns the inverse of this instance.
- getInverse() - Method in interface org.hipparchus.linear.DecompositionSolver
-
- getInverse() - Method in interface org.hipparchus.linear.FieldDecompositionSolver
-
Get the inverse (or pseudo-inverse) of the decomposed matrix.
- getInverseConditionNumber() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Computes the inverse of the condition number.
- getIterationCounter() - Method in class org.hipparchus.optim.AbstractOptimizationProblem
-
Get a independent Incrementor that counts up to the maximum number of iterations
and then throws an exception.
- getIterationCounter() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
-
Get a independent Incrementor that counts up to the maximum number of iterations
and then throws an exception.
- getIterationCounter() - Method in interface org.hipparchus.optim.OptimizationProblem
-
Get a independent Incrementor that counts up to the maximum number of iterations
and then throws an exception.
- getIterationManager() - Method in class org.hipparchus.linear.IterativeLinearSolver
-
Returns the iteration manager attached to this solver.
- getIterations() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the number of iterations of the last run of the integrator.
- getIterations() - Method in interface org.hipparchus.analysis.integration.UnivariateIntegrator
-
Get the number of iterations of the last run of the integrator.
- getIterations() - Method in class org.hipparchus.optim.BaseOptimizer
-
Gets the number of iterations performed by the algorithm.
- getIterations() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresOptimizer.Optimum
-
Get the number of times the algorithm iterated in order to produce this
optimum.
- getIterations() - Method in class org.hipparchus.util.IterationEvent
-
Returns the number of iterations performed at the time this
event
is created.
- getIterations() - Method in class org.hipparchus.util.IterationManager
-
Returns the number of iterations of this solver, 0 if no iterations has
been performed yet.
- getJacobian() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
-
Get the weighted Jacobian matrix.
- getK() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Return the number of clusters this instance will use.
- getK() - Method in class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
Return the number of clusters this instance will use.
- getK() - Method in interface org.hipparchus.linear.RiccatiEquationSolver
-
Get the linear controller k.
- getK() - Method in class org.hipparchus.linear.RiccatiEquationSolverImpl
-
{inheritDoc}
- getK() - Method in class org.hipparchus.util.Combinations
-
Gets the number of elements in each combination.
- getKernel(StreamingStatistics) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
The within-bin smoothing kernel.
- getKey() - Method in class org.hipparchus.util.Pair
-
Get the key.
- getKnots() - Method in class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Get an array copy of the knot points.
- getKthSelector() - Method in class org.hipparchus.stat.descriptive.rank.Median
-
- getKthSelector() - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
- getKurtosis() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the Kurtosis of the available values.
- getL() - Method in class org.hipparchus.linear.CholeskyDecomposition
-
Returns the matrix L of the decomposition.
- getL() - Method in class org.hipparchus.linear.FieldLUDecomposition
-
Returns the matrix L of the decomposition.
- getL() - Method in class org.hipparchus.linear.LUDecomposition
-
Returns the matrix L of the decomposition.
- getL1Distance(OpenMapRealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Distance between two vectors.
- getL1Distance(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Distance between two vectors.
- getL1Distance(RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Distance between two vectors.
- getL1Distance(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Distance between two vectors.
- getL1Norm() - Method in class org.hipparchus.linear.ArrayRealVector
-
Returns the L1 norm of the vector.
- getL1Norm() - Method in class org.hipparchus.linear.RealVector
-
Returns the L1 norm of the vector.
- getLeftAbscissa() - Method in class org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
-
Get the left abscissa.
- getLeftAbscissa() - Method in class org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
-
Get the left abscissa.
- getLeftValue() - Method in class org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
-
- getLeftValue() - Method in class org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
-
- getLength() - Method in class org.hipparchus.geometry.spherical.twod.Edge
-
Get the length of the arc.
- getLine() - Method in class org.hipparchus.geometry.euclidean.threed.Segment
-
Get the line containing the segment.
- getLine() - Method in class org.hipparchus.geometry.euclidean.twod.Segment
-
Get the line containing the segment.
- getLineSegments() - Method in class org.hipparchus.geometry.euclidean.twod.hull.ConvexHull2D
-
Get the line segments of the convex hull, ordered.
- getLInfDistance(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Distance between two vectors.
- getLInfDistance(RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Distance between two vectors.
- getLInfDistance(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Distance between two vectors.
- getLInfNorm() - Method in class org.hipparchus.linear.ArrayRealVector
-
Returns the L∞ norm of the vector.
- getLInfNorm() - Method in class org.hipparchus.linear.RealVector
-
Returns the L∞ norm of the vector.
- getLn10() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant ln(10).
- getLn2() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant ln(2).
- getLn2Split() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant ln(2) split in two pieces.
- getLn5() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant ln(5).
- getLn5Split() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant ln(5) split in two pieces.
- getLo() - Method in exception org.hipparchus.migration.exception.NoBracketingException
-
Deprecated.
Get the lower end of the interval.
- getLo() - Method in exception org.hipparchus.migration.exception.OutOfRangeException
-
Deprecated.
- getLo() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
- getLocalizedMessage() - Method in exception org.hipparchus.exception.MathRuntimeException
- getLocalizedMessage() - Method in exception org.hipparchus.exception.NullArgumentException
- getLocalizedString(Locale) - Method in enum org.hipparchus.clustering.LocalizedClusteringFormats
-
Gets the localized string.
- getLocalizedString(Locale) - Method in class org.hipparchus.exception.DummyLocalizable
-
Gets the localized string.
- getLocalizedString(Locale) - Method in interface org.hipparchus.exception.Localizable
-
Gets the localized string.
- getLocalizedString(Locale) - Method in enum org.hipparchus.exception.LocalizedCoreFormats
-
Gets the localized string.
- getLocalizedString(Locale) - Method in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
Gets the localized string.
- getLocalizedString(Locale) - Method in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
Gets the localized string.
- getLocalizedString(Locale) - Method in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
Gets the localized string.
- getLocalizedString(Locale) - Method in enum org.hipparchus.ode.LocalizedODEFormats
-
Gets the localized string.
- getLocalizedString(Locale) - Method in enum org.hipparchus.optim.LocalizedOptimFormats
-
Gets the localized string.
- getLocalizedString(Locale) - Method in enum org.hipparchus.stat.LocalizedStatFormats
-
Gets the localized string.
- getLocalizedString(Locale) - Method in enum org.hipparchus.transform.LocalizedFFTFormats
-
Gets the localized string.
- getLocation() - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
Access the location parameter, mu
.
- getLocation() - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Access the location parameter, mu
.
- getLocation() - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Get the location parameter of the distribution.
- getLocation() - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
Access the location parameter, mu
.
- getLocation() - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Get the hyperplane location on the real line.
- getLocation() - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Get the hyperplane location on the circle.
- getLocation() - Method in class org.hipparchus.geometry.spherical.twod.Vertex
-
Get Vertex location.
- getLogLikelihood() - Method in class org.hipparchus.stat.fitting.MultivariateNormalMixtureExpectationMaximization
-
Gets the log likelihood of the data under the fitted model.
- getLower() - Method in class org.hipparchus.optim.SimpleBounds
-
Gets the lower bounds.
- getLowerBound() - Method in class org.hipparchus.optim.BaseMultivariateOptimizer
-
- getLowerBound() - Method in class org.hipparchus.stat.interval.ConfidenceInterval
-
- getLT() - Method in class org.hipparchus.linear.CholeskyDecomposition
-
Returns the transpose of the matrix L of the decomposition.
- getMainPanel() - Method in class org.hipparchus.samples.ExampleUtils.ExampleFrame
-
Returns the main panel which should be printed by the screenshot action.
- getMainPanel() - Method in class org.hipparchus.samples.geometry.GeometryExample.Display
-
- getMainPanel() - Method in class org.hipparchus.samples.IntegerDistributionComparison.Display
-
- getMainPanel() - Method in class org.hipparchus.samples.RealDistributionComparison.Display
-
- getMapper() - Method in class org.hipparchus.ode.ExpandableODE
-
Get the mapper for the set of equations.
- getMapper() - Method in class org.hipparchus.ode.FieldExpandableODE
-
Get the mapper for the set of equations.
- getMapper() - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Get the mapper for ODE equations primary and secondary components.
- getMapper() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Get the mapper for ODE equations primary and secondary components.
- getMatrix() - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Get the 3X3 matrix corresponding to the instance
- getMatrix() - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Get the 3X3 matrix corresponding to the instance
- getMax() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
- getMax() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
- getMax() - Method in exception org.hipparchus.migration.exception.MaxCountExceededException
-
Deprecated.
- getMax() - Method in exception org.hipparchus.migration.exception.NumberIsTooLargeException
-
Deprecated.
- getMax() - Method in class org.hipparchus.optim.univariate.SearchInterval
-
Gets the upper bound.
- getMax() - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
- getMax() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the maximum of the available values
- getMax() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns an array whose ith entry is the
maximum of the ith entries of the arrays
that correspond to each multivariate sample
- getMax() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
maximum of the ith entries of the arrays
that correspond to each multivariate sample
- getMax() - Method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
Returns the maximum of the available values
- getMax() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
- getMax() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the maximum of the available values
- getMaxCheckInterval() - Method in class org.hipparchus.ode.events.EventState
-
Get the maximal time interval between events handler checks.
- getMaxCheckInterval() - Method in class org.hipparchus.ode.events.FieldEventState
-
Get the maximal time interval between events handler checks.
- getMaxEval() - Method in class org.hipparchus.optim.MaxEval
-
Gets the maximum number of evaluations.
- getMaxEvaluations() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the maximum number of function evaluations.
- getMaxEvaluations() - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Get the maximum number of function evaluations.
- getMaxEvaluations() - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Get the maximum number of function evaluations.
- getMaxEvaluations() - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Get the maximal number of function evaluations.
- getMaxEvaluations() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get the maximal number of functions evaluations.
- getMaxEvaluations() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get the maximal number of functions evaluations.
- getMaxEvaluations() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Get the maximal number of functions evaluations.
- getMaxEvaluations() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Get the maximal number of functions evaluations.
- getMaxEvaluations() - Method in class org.hipparchus.optim.BaseOptimizer
-
Gets the maximal number of function evaluations.
- getMaxEvaluations() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
- getMaxGrowth() - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Get the maximal growth factor for stepsize control.
- getMaxGrowth() - Method in class org.hipparchus.ode.MultistepIntegrator
-
Get the maximal growth factor for stepsize control.
- getMaxGrowth() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Get the maximal growth factor for stepsize control.
- getMaxGrowth() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the maximal growth factor for stepsize control.
- getMaximalCount() - Method in class org.hipparchus.util.Incrementor
-
Gets the upper limit of the counter.
- getMaximalIterationCount() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the upper limit for the number of iterations.
- getMaximalIterationCount() - Method in interface org.hipparchus.analysis.integration.UnivariateIntegrator
-
Get the upper limit for the number of iterations.
- getMaximalOrder() - Method in class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Get the maximal order.
- getMaximalOrder() - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Get the maximal order.
- getMaxIndex() - Method in class org.hipparchus.linear.RealVector
-
Get the index of the maximum entry.
- getMaxIter() - Method in class org.hipparchus.optim.MaxIter
-
Gets the maximum number of evaluations.
- getMaxIterationCount() - Method in class org.hipparchus.ode.events.EventState
-
Get the upper limit in the iteration count for event localization.
- getMaxIterationCount() - Method in class org.hipparchus.ode.events.FieldEventState
-
Get the upper limit in the iteration count for event localization.
- getMaxIterations() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Returns the maximum number of iterations this instance will use.
- getMaxIterations() - Method in class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
Returns the maximum number of iterations this instance will use.
- getMaxIterations() - Method in class org.hipparchus.optim.BaseOptimizer
-
Gets the maximal number of iterations.
- getMaxIterations() - Method in class org.hipparchus.util.IterationManager
-
Returns the maximum number of iterations.
- getMaxStep() - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Get the maximal step.
- getMaxStep() - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Get the maximal step.
- getMaxValue() - Method in class org.hipparchus.linear.RealVector
-
Get the value of the maximum entry.
- getMean() - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Access the mean.
- getMean() - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Access the mean.
- getMean() - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
Get the mean for the distribution.
- getMean() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
- getMean() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns an array whose ith entry is the
mean of the ith entries of the arrays
that correspond to each multivariate sample
- getMean() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
mean of the ith entries of the arrays
that correspond to each multivariate sample
- getMean() - Method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
- getMean() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
- getMean() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
- getMeans() - Method in class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Gets the mean vector.
- getMeanSquareError() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the sum of squared errors divided by the degrees of freedom,
usually abbreviated MSE.
- getMeanSquareError() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the sum of squared errors divided by the degrees of freedom,
usually abbreviated MSE.
- getMeasurementJacobian() - Method in class org.hipparchus.filtering.kalman.extended.NonLinearEvolution
-
Get measurement Jacobian.
- getMeasurementJacobian() - Method in class org.hipparchus.filtering.kalman.linear.LinearEvolution
-
Get measurement Jacobian.
- getMedian() - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
Access the median.
- getMedian() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns an estimate of the median of the values that have been entered.
- getMembershipMatrix() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Returns the nxk
membership matrix, where n
is the number
of data points and k
the number of clusters.
- getMessage() - Method in exception org.hipparchus.exception.MathRuntimeException
- getMessage() - Method in exception org.hipparchus.exception.NullArgumentException
- getMessage(Locale) - Method in interface org.hipparchus.exception.LocalizedException
-
Gets the message in a specified locale.
- getMessage(Locale) - Method in exception org.hipparchus.exception.MathRuntimeException
-
Gets the message in a specified locale.
- getMessage(Locale) - Method in exception org.hipparchus.exception.NullArgumentException
-
Gets the message in a specified locale.
- getMid() - Method in class org.hipparchus.optim.univariate.BracketFinder
-
- getMin() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
- getMin() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
- getMin() - Method in exception org.hipparchus.migration.exception.NumberIsTooSmallException
-
Deprecated.
- getMin() - Method in class org.hipparchus.optim.univariate.SearchInterval
-
Gets the lower bound.
- getMin() - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
- getMin() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the minimum of the available values
- getMin() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns an array whose ith entry is the
minimum of the ith entries of the arrays
that correspond to each multivariate sample
- getMin() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
minimum of the ith entries of the arrays
that correspond to each multivariate sample
- getMin() - Method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
Returns the minimum of the available values
- getMin() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
- getMin() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the minimum of the available values
- getMinimalIterationCount() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the min limit for the number of iterations.
- getMinimalIterationCount() - Method in interface org.hipparchus.analysis.integration.UnivariateIntegrator
-
Get the min limit for the number of iterations.
- getMinIndex() - Method in class org.hipparchus.linear.RealVector
-
Get the index of the minimum entry.
- getMinPts() - Method in class org.hipparchus.clustering.DBSCANClusterer
-
Returns the minimum number of points needed for a cluster.
- getMinReduction() - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Get the minimal reduction factor for stepsize control.
- getMinReduction() - Method in class org.hipparchus.ode.MultistepIntegrator
-
Get the minimal reduction factor for stepsize control.
- getMinReduction() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Get the minimal reduction factor for stepsize control.
- getMinReduction() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the minimal reduction factor for stepsize control.
- getMinStep() - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Get the minimal step.
- getMinStep() - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Get the minimal step.
- getMinus() - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Get the tree on the minus side of the cut hyperplane.
- getMinus() - Method in class org.hipparchus.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Get the part of the sub-hyperplane on the minus side of the splitting hyperplane.
- getMinus() - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet.Split
-
Get the part of the arcs set on the minus side of the splitting arc.
- getMinusI(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get opposite of the first canonical vector (coordinates: -1, 0, 0).
- getMinusJ(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get opposite of the second canonical vector (coordinates: 0, -1, 0).
- getMinusK(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get opposite of the third canonical vector (coordinates: 0, 0, -1).
- getMinValue() - Method in class org.hipparchus.linear.RealVector
-
Get the value of the minimum entry.
- getMode() - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
Returns the mode c
of this distribution.
- getMode() - Method in class org.hipparchus.stat.Frequency
-
Returns the mode value(s) in comparator order.
- getModelFunction() - Method in class org.hipparchus.fitting.AbstractCurveFitter.TheoreticalValuesFunction
-
- getModelFunctionJacobian() - Method in class org.hipparchus.fitting.AbstractCurveFitter.TheoreticalValuesFunction
-
- getN() - Method in class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Get the number of spline segments.
- getN() - Method in class org.hipparchus.stat.correlation.Covariance
-
Returns the number of observations (length of covariate vectors)
- getN() - Method in class org.hipparchus.stat.correlation.StorelessCovariance
-
- getN() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the number of available values
- getN() - Method in class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.moment.Mean
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.moment.Skewness
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns the number of available values
- getN() - Method in class org.hipparchus.stat.descriptive.rank.Max
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.rank.Min
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
- getN() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns the number of available values
- getN() - Method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
Returns the number of available values
- getN() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
- getN() - Method in interface org.hipparchus.stat.descriptive.StorelessMultivariateStatistic
-
Returns the number of values that have been added.
- getN() - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the number of available values
- getN() - Method in class org.hipparchus.stat.descriptive.summary.Product
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.summary.Sum
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.descriptive.vector.VectorialCovariance
-
Get the number of vectors in the sample.
- getN() - Method in class org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
-
Returns the number of values that have been added.
- getN() - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Gets the number of observations added to the regression model.
- getN() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the number of observations added to the regression model.
- getN() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the number of observations that have been added to the model.
- getN() - Method in interface org.hipparchus.stat.regression.UpdatingMultipleLinearRegression
-
Returns the number of observations added to the regression model.
- getN() - Method in class org.hipparchus.util.Combinations
-
Gets the size of the set from which combinations are drawn.
- getName() - Method in exception org.hipparchus.migration.ode.UnknownParameterException
-
Deprecated.
- getName() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get the name of the method.
- getName() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get the name of the method.
- getName() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Get the name of the method.
- getName() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Get the name of the method.
- getNaN(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a vector with all coordinates set to NaN.
- getNanStrategy() - Method in class org.hipparchus.stat.ranking.NaturalRanking
-
Return the NaNStrategy
- getNaNStrategy() - Method in class org.hipparchus.stat.descriptive.rank.Median
-
- getNaNStrategy() - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
- getNbPoints() - Method in class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Get the number of points to use.
- getNegativeInfinity(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a vector with all coordinates set to negative infinity.
- getNewState() - Method in class org.hipparchus.ode.events.EventState.EventOccurrence
-
Get the new state for a reset action.
- getNewState() - Method in class org.hipparchus.ode.events.FieldEventState.EventOccurrence
-
Get the new state for a reset action.
- getNewtonCoefficients() - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Returns a copy of coefficients in Newton form formula.
- getNextIndex() - Method in class org.hipparchus.random.HaltonSequenceGenerator
-
- getNextIndex() - Method in class org.hipparchus.random.SobolSequenceGenerator
-
- getNextValue() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Generates a random value from this distribution.
- getNorm() - Method in class org.hipparchus.complex.Quaternion
-
Computes the norm of the quaternion.
- getNorm() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get the L2 norm for the vector.
- getNorm() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the L2 norm for the vector.
- getNorm() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the L2 norm for the vector.
- getNorm() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the L2 norm for the vector.
- getNorm() - Method in interface org.hipparchus.geometry.Vector
-
Get the L2 norm for the vector.
- getNorm() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
- getNorm() - Method in class org.hipparchus.linear.ArrayRealVector
-
Returns the L2 norm of the vector.
- getNorm() - Method in class org.hipparchus.linear.BlockRealMatrix
-
- getNorm() - Method in interface org.hipparchus.linear.RealMatrix
-
- getNorm() - Method in class org.hipparchus.linear.RealVector
-
Returns the L2 norm of the vector.
- getNorm() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Returns the L2 norm of the matrix.
- getNorm1() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get the L1 norm for the vector.
- getNorm1() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the L1 norm for the vector.
- getNorm1() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the L1 norm for the vector.
- getNorm1() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the L1 norm for the vector.
- getNorm1() - Method in interface org.hipparchus.geometry.Vector
-
Get the L1 norm for the vector.
- getNormal() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the normalized normal vector.
- getNormalApproximationInterval(int, double, double) - Static method in class org.hipparchus.stat.interval.BinomialProportion
-
Create a binomial confidence interval using normal approximation
for the true probability of success of an unknown binomial distribution
with the given observed number of trials, probability of success and
confidence level.
- getNormInf() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the L∞ norm for the vector.
- getNormInf() - Method in interface org.hipparchus.geometry.Vector
-
Get the L∞ norm for the vector.
- getNormOfResidual() - Method in class org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Returns the norm of the residual.
- getNormOfResidual() - Method in class org.hipparchus.linear.IterativeLinearSolverEvent
-
Returns the norm of the residual.
- getNormSq() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get the square of the norm for the vector.
- getNormSq() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the square of the norm for the vector.
- getNormSq() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the square of the norm for the vector.
- getNormSq() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the square of the norm for the vector.
- getNormSq() - Method in interface org.hipparchus.geometry.Vector
-
Get the square of the norm for the vector.
- getNSteps() - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Get the number of steps of the multistep method (excluding the one being computed).
- getNSteps() - Method in class org.hipparchus.ode.MultistepIntegrator
-
Get the number of steps of the multistep method (excluding the one being computed).
- getNSteps() - Method in class org.hipparchus.ode.nonstiff.AdamsNordsieckTransformer
-
- getNumberOfElements() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
Get the number of elements (e.g.
- getNumberOfEquations() - Method in class org.hipparchus.ode.EquationsMapper
-
Get the number of equations mapped.
- getNumberOfEquations() - Method in class org.hipparchus.ode.FieldEquationsMapper
-
Get the number of equations mapped.
- getNumberOfParameters() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the number of parameters estimated in the model.
- getNumberOfPoints() - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegrator
-
- getNumberOfRoots() - Method in class org.hipparchus.complex.RootsOfUnity
-
Returns the number of roots of unity currently stored.
- getNumberOfSecondaryStates() - Method in class org.hipparchus.ode.FieldODEState
-
Get the number of secondary states.
- getNumberOfSecondaryStates() - Method in class org.hipparchus.ode.ODEState
-
Get the number of secondary states.
- getNumberOfSuccesses() - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
Access the number of successes.
- getNumberOfSuccesses() - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
Access the number of successes for this distribution.
- getNumberOfTrials() - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
Access the number of trials for this distribution.
- getNumElements() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Returns the number of elements currently in the array.
- getNumerator() - Method in class org.hipparchus.fraction.BigFraction
-
Access the numerator as a BigInteger
.
- getNumerator() - Method in class org.hipparchus.fraction.Fraction
-
Access the numerator.
- getNumeratorAsInt() - Method in class org.hipparchus.fraction.BigFraction
-
Access the numerator as a int
.
- getNumeratorAsLong() - Method in class org.hipparchus.fraction.BigFraction
-
Access the numerator as a long
.
- getNumeratorDegreesOfFreedom() - Method in class org.hipparchus.distribution.continuous.FDistribution
-
Access the numerator degrees of freedom.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.FDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.TDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.UniformRealDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.discrete.UniformIntegerDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in interface org.hipparchus.distribution.IntegerDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in interface org.hipparchus.distribution.RealDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalMean() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Use this method to get the numerical value of the mean of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.FDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.TDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.UniformRealDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.discrete.UniformIntegerDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in interface org.hipparchus.distribution.IntegerDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in interface org.hipparchus.distribution.RealDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumericalVariance() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Use this method to get the numerical value of the variance of this
distribution.
- getNumTrials() - Method in class org.hipparchus.clustering.MultiKMeansPlusPlusClusterer
-
Returns the number of trials this instance will do.
- getnVals() - Method in class org.hipparchus.special.BesselJ.BesselJResult
-
- getObjectiveFunction() - Method in class org.hipparchus.optim.nonlinear.scalar.ObjectiveFunction
-
Gets the function to be optimized.
- getObjectiveFunction() - Method in class org.hipparchus.optim.univariate.UnivariateObjectiveFunction
-
Gets the function to be optimized.
- getObjectiveFunctionGradient() - Method in class org.hipparchus.optim.nonlinear.scalar.ObjectiveFunctionGradient
-
Gets the gradient of the function to be optimized.
- getObjectiveFunctionValue() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Get the value of the objective function.
- getObservationSize() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
-
Get the number of observations (rows in the Jacobian) in this problem.
- getObservationSize() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem
-
Get the number of observations (rows in the Jacobian) in this problem.
- getOffset() - Method in class org.hipparchus.geometry.partitioning.BoundaryProjection
-
Offset of the point with respect to the boundary it is projected on.
- getOffset(Plane) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the offset (oriented distance) of a parallel plane.
- getOffset(Vector3D) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the offset (oriented distance) of a direction.
- getOffset(Line) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get the offset (oriented distance) of a parallel line.
- getOffset(Point<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Get the offset (oriented distance) of a point.
- getOffset(Point<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the offset (oriented distance) of a point.
- getOffset(Point<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get the offset (oriented distance) of a point.
- getOffset(Point<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Get the offset (oriented distance) of a point.
- getOffset(Point<Sphere2D>) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the offset (oriented distance) of a point.
- getOffset(Point<S>) - Method in interface org.hipparchus.geometry.partitioning.Hyperplane
-
Get the offset (oriented distance) of a point.
- getOffset(Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Get the offset (oriented distance) of a vector.
- getOffset(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the offset (oriented distance) of a vector.
- getOffset(Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get the offset (oriented distance) of a vector.
- getOmegaInverse() - Method in class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
Get the inverse of the covariance.
- getOne() - Method in class org.hipparchus.complex.ComplexField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.dfp.Dfp
-
Get the constant 1.
- getOne() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant 1.
- getOne() - Method in interface org.hipparchus.Field
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.fraction.BigFractionField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.fraction.FractionField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.util.BigRealField
-
Get the multiplicative identity of the field.
- getOne() - Method in class org.hipparchus.util.Decimal64Field
-
Get the multiplicative identity of the field.
- getOptima() - Method in class org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
-
Gets all the optima found during the last call to optimize
.
- getOptima() - Method in class org.hipparchus.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
-
Gets all the optima found during the last call to optimize
.
- getOptima() - Method in class org.hipparchus.optim.univariate.MultiStartUnivariateOptimizer
-
Gets all the optima found during the last call to optimize
.
- getOptimizer() - Method in class org.hipparchus.fitting.AbstractCurveFitter
-
Creates an optimizer set up to fit the appropriate curve.
- getOrder() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the derivation order.
- getOrder() - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Get the derivation order.
- getOrder() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the derivation order.
- getOrder() - Method in class org.hipparchus.ode.nonstiff.DormandPrince54FieldIntegrator
-
Get the order of the method.
- getOrder() - Method in class org.hipparchus.ode.nonstiff.DormandPrince54Integrator
-
Get the order of the method.
- getOrder() - Method in class org.hipparchus.ode.nonstiff.DormandPrince853FieldIntegrator
-
Get the order of the method.
- getOrder() - Method in class org.hipparchus.ode.nonstiff.DormandPrince853Integrator
-
Get the order of the method.
- getOrder() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Get the order of the method.
- getOrder() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the order of the method.
- getOrder() - Method in class org.hipparchus.ode.nonstiff.HighamHall54FieldIntegrator
-
Get the order of the method.
- getOrder() - Method in class org.hipparchus.ode.nonstiff.HighamHall54Integrator
-
Get the order of the method.
- getOrderOfRegressors() - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
Gets the order of the regressors, useful if some type of reordering
has been called.
- getOrigin() - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Get the line point closest to the origin.
- getOrigin() - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Get the line point closest to the origin.
- getOrigin() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the origin point of the plane frame.
- getOriginal() - Method in class org.hipparchus.geometry.partitioning.BoundaryProjection
-
Get the original point.
- getOriginOffset() - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get the offset of the origin.
- getOrthoTolerance() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Gets the value of a tuning parameter.
- getOutgoing() - Method in class org.hipparchus.geometry.spherical.twod.Vertex
-
Get outgoing edge.
- getOutline(PolyhedronsSet) - Method in class org.hipparchus.geometry.euclidean.threed.OutlineExtractor
-
Extract the outline of a polyhedrons set.
- getP() - Method in class org.hipparchus.linear.FieldLUDecomposition
-
Returns the P rows permutation matrix.
- getP() - Method in class org.hipparchus.linear.LUDecomposition
-
Returns the P rows permutation matrix.
- getP() - Method in interface org.hipparchus.linear.RiccatiEquationSolver
-
Get the solution.
- getP() - Method in class org.hipparchus.linear.RiccatiEquationSolverImpl
-
{inheritDoc}
- getP() - Method in class org.hipparchus.linear.RRQRDecomposition
-
Returns the pivot matrix, P, used in the QR Decomposition of matrix A such that AP = QR.
- getParameter(String) - Method in interface org.hipparchus.ode.ParametersController
-
Get parameter value from its name.
- getParameterEstimate(int) - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the parameter estimate for the regressor at the given index.
- getParameterEstimates() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns a copy of the regression parameters estimates.
- getParameterName() - Method in class org.hipparchus.ode.ParameterConfiguration
-
Get parameter name.
- getParameterRelativeTolerance() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Gets the value of a tuning parameter.
- getParameterSize() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
-
Get the number of parameters (columns in the Jacobian) in this problem.
- getParameterSize() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem
-
Get the number of parameters (columns in the Jacobian) in this problem.
- getParametersNames() - Method in class org.hipparchus.ode.AbstractParameterizable
-
Get the names of the supported parameters.
- getParametersNames() - Method in interface org.hipparchus.ode.ODEJacobiansProvider
-
Get the names of the supported parameters.
- getParametersNames() - Method in interface org.hipparchus.ode.Parameterizable
-
Get the names of the supported parameters.
- getParent() - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Get the parent node.
- getPartialCorrelations(int) - Method in class org.hipparchus.stat.regression.MillerUpdatingRegression
-
In the original algorithm only the partial correlations of the regressors
is returned to the user.
- getPartialDerivative(int...) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get a partial derivative.
- getPartialDerivative(int...) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get a partial derivative.
- getPartialDerivativeIndex(int...) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Get the index of a partial derivative in the array.
- getPartialDerivativeOrders(int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Get the derivation orders for a specific index in the array.
- getParts() - Method in interface org.hipparchus.exception.LocalizedException
-
Get the variable parts of the error message.
- getParts() - Method in exception org.hipparchus.exception.MathRuntimeException
-
Get the variable parts of the error message.
- getParts() - Method in exception org.hipparchus.exception.NullArgumentException
-
Get the variable parts of the error message.
- getPct(int) - Method in class org.hipparchus.stat.LongFrequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPct(T) - Method in class org.hipparchus.stat.Frequency
-
Returns the percentage of values that are equal to v
(as a proportion between 0 and 1).
- getPercentile(double) - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns an estimate for the pth percentile of the stored values.
- getPercentile(double) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns an estimate of the given percentile of the values that have been entered.
- getPercentileValue() - Method in interface org.hipparchus.stat.descriptive.rank.PSquarePercentile.PSquareMarkers
-
Returns Percentile value computed thus far.
- getPhase(Vector3D) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the phase angle of a direction.
- getPhi() - Method in class org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
-
Get the polar (co-latitude) angle.
- getPhi() - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Get the polar angle \( \varphi \).
- getPi() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant π.
- getPiSplit() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant π split in two pieces.
- getPivot() - Method in class org.hipparchus.linear.FieldLUDecomposition
-
Returns the pivot permutation vector.
- getPivot() - Method in class org.hipparchus.linear.LUDecomposition
-
Returns the pivot permutation vector.
- getPivotingStrategy() - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
- getPivotingStrategy() - Method in class org.hipparchus.util.KthSelector
-
Get the pivoting strategy.
- getPlus() - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Get the tree on the plus side of the cut hyperplane.
- getPlus() - Method in class org.hipparchus.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Get the part of the sub-hyperplane on the plus side of the splitting hyperplane.
- getPlus() - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet.Split
-
Get the part of the arcs set on the plus side of the splitting arc.
- getPlusI(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get first canonical vector (coordinates: 1, 0, 0).
- getPlusInside() - Method in class org.hipparchus.geometry.partitioning.BoundaryAttribute
-
Get the part of the node cut sub-hyperplane that belongs to the
boundary and has the inside of the region on the plus side of
its underlying hyperplane.
- getPlusJ(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get second canonical vector (coordinates: 0, 1, 0).
- getPlusK(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get third canonical vector (coordinates: 0, 0, 1).
- getPlusOutside() - Method in class org.hipparchus.geometry.partitioning.BoundaryAttribute
-
Get the part of the node cut sub-hyperplane that belongs to the
boundary and has the outside of the region on the plus side of
its underlying hyperplane.
- getPmf() - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Return the probability mass function as a list of (value, probability) pairs.
- getPmf() - Method in class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Return the probability mass function as a list of (value, probability) pairs.
- getPmf() - Method in class org.hipparchus.distribution.EnumeratedDistribution
-
Return the probability mass function as a list of (value, probability) pairs.
- getPoint() - Method in interface org.hipparchus.clustering.Clusterable
-
Gets the n-dimensional point.
- getPoint() - Method in class org.hipparchus.clustering.DoublePoint
-
Gets the n-dimensional point.
- getPoint() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
-
Get the abscissa (independent variables) of this evaluation.
- getPoint() - Method in class org.hipparchus.optim.PointValuePair
-
Gets the point.
- getPoint() - Method in class org.hipparchus.optim.PointVectorValuePair
-
Gets the point.
- getPoint() - Method in class org.hipparchus.optim.univariate.UnivariatePointValuePair
-
Get the point.
- getPoint(int) - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegrator
-
Gets the integration point at the given index.
- getPoint(int) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Get the simplex point stored at the requested index
.
- getPointAt(double) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get a circle point from its phase around the circle.
- getPointAt(double) - Method in class org.hipparchus.geometry.spherical.twod.Edge
-
Get an intermediate point.
- getPointAt(Vector1D, double) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get one point from the plane.
- getPointAt(Vector2D, double) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get one point from the 3D-space.
- getPointRef() - Method in class org.hipparchus.optim.PointValuePair
-
Gets a reference to the point.
- getPointRef() - Method in class org.hipparchus.optim.PointVectorValuePair
-
Gets a reference to the point.
- getPoints() - Method in class org.hipparchus.clustering.Cluster
-
Get the points contained in the cluster.
- getPoints() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Get the points of the simplex.
- getPole() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the pole of the circle.
- getPolynomials() - Method in class org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Compute the interpolation polynomials.
- getPolynomials() - Method in class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Get a copy of the interpolating polynomials array.
- getPopulationSize() - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
Access the population size.
- getPopulationSize() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer.PopulationSize
-
- getPopulationVariance() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the population variance of the available values.
- getPopulationVariance() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
- getPositiveInfinity(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get a vector with all coordinates set to positive infinity.
- getPositivePolarForm() - Method in class org.hipparchus.complex.Quaternion
-
Returns the polar form of the quaternion.
- getPredicted() - Method in class org.hipparchus.filtering.kalman.AbstractKalmanFilter
-
Get the predicted state.
- getPredicted() - Method in interface org.hipparchus.filtering.kalman.KalmanFilter
-
Get the current predicted state.
- getPreferredSize() - Method in class org.hipparchus.samples.ClusterAlgorithmComparison.ClusterPlot
-
- getPreferredSize() - Method in class org.hipparchus.samples.LowDiscrepancyGeneratorComparison.Plot
-
- getPrefix() - Method in class org.hipparchus.geometry.VectorFormat
-
Get the format prefix.
- getPrefix() - Method in class org.hipparchus.linear.RealMatrixFormat
-
Get the format prefix.
- getPrefix() - Method in class org.hipparchus.linear.RealVectorFormat
-
Get the format prefix.
- getPrevious() - Method in exception org.hipparchus.migration.exception.NonMonotonicSequenceException
-
Deprecated.
- getPreviousState() - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Get the state at previous grid point time.
- getPreviousState() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Get the state at previous grid point time.
- getPreviousState() - Method in interface org.hipparchus.ode.sampling.FieldODEStateInterpolator
-
Get the state at previous grid point time.
- getPreviousState() - Method in interface org.hipparchus.ode.sampling.ODEStateInterpolator
-
Get the state at previous grid point time.
- getPreviousTime() - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
- getPrimary() - Method in class org.hipparchus.ode.ExpandableODE
-
Get the primaryset of differential equations to be integrated.
- getPrimaryDerivative() - Method in class org.hipparchus.ode.FieldODEStateAndDerivative
-
Get derivative of the primary state at time.
- getPrimaryDerivative() - Method in class org.hipparchus.ode.ODEStateAndDerivative
-
Get derivative of the primary state at time.
- getPrimaryState() - Method in class org.hipparchus.ode.FieldODEState
-
Get primary state at time.
- getPrimaryState() - Method in class org.hipparchus.ode.ODEState
-
Get primary state at time.
- getPrimaryStateDimension() - Method in class org.hipparchus.ode.FieldODEState
-
Get primary state dimension.
- getPrimaryStateDimension() - Method in class org.hipparchus.ode.ODEState
-
Get primary state dimension.
- getProbabilityOfSuccess() - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
Access the probability of success for this distribution.
- getProbabilityOfSuccess() - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
Access the probability of success for this distribution.
- getProbabilityOfSuccess() - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
Access the probability of success for this distribution.
- getProblem(Collection<WeightedObservedPoint>) - Method in class org.hipparchus.fitting.AbstractCurveFitter
-
Creates a least squares problem corresponding to the appropriate curve.
- getProblem(Collection<WeightedObservedPoint>) - Method in class org.hipparchus.fitting.GaussianCurveFitter
-
Creates a least squares problem corresponding to the appropriate curve.
- getProblem(Collection<WeightedObservedPoint>) - Method in class org.hipparchus.fitting.HarmonicCurveFitter
-
Creates a least squares problem corresponding to the appropriate curve.
- getProblem(Collection<WeightedObservedPoint>) - Method in class org.hipparchus.fitting.PolynomialCurveFitter
-
Creates a least squares problem corresponding to the appropriate curve.
- getProblem(Collection<WeightedObservedPoint>) - Method in class org.hipparchus.fitting.SimpleCurveFitter
-
Creates a least squares problem corresponding to the appropriate curve.
- getProcessNoiseMatrix() - Method in class org.hipparchus.filtering.kalman.extended.NonLinearEvolution
-
Get process noise.
- getProcessNoiseMatrix() - Method in class org.hipparchus.filtering.kalman.linear.LinearEvolution
-
Get the process noise matrix Qk-1.
- getProjected() - Method in class org.hipparchus.geometry.partitioning.BoundaryProjection
-
Projected point.
- getProperInstance() - Static method in class org.hipparchus.fraction.BigFractionFormat
-
Returns the default complex format for the current locale.
- getProperInstance() - Static method in class org.hipparchus.fraction.FractionFormat
-
Returns the default complex format for the current locale.
- getProperInstance(Locale) - Static method in class org.hipparchus.fraction.BigFractionFormat
-
Returns the default complex format for the given locale.
- getProperInstance(Locale) - Static method in class org.hipparchus.fraction.FractionFormat
-
Returns the default complex format for the given locale.
- getQ() - Method in class org.hipparchus.linear.FieldQRDecomposition
-
Returns the matrix Q of the decomposition.
- getQ() - Method in class org.hipparchus.linear.QRDecomposition
-
Returns the matrix Q of the decomposition.
- getQ0() - Method in class org.hipparchus.complex.Quaternion
-
Gets the first component of the quaternion (scalar part).
- getQ0() - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Get the scalar coordinate of the quaternion.
- getQ0() - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Get the scalar coordinate of the quaternion.
- getQ1() - Method in class org.hipparchus.complex.Quaternion
-
Gets the second component of the quaternion (first component
of the vector part).
- getQ1() - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Get the first coordinate of the vectorial part of the quaternion.
- getQ1() - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Get the first coordinate of the vectorial part of the quaternion.
- getQ2() - Method in class org.hipparchus.complex.Quaternion
-
Gets the third component of the quaternion (second component
of the vector part).
- getQ2() - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Get the second coordinate of the vectorial part of the quaternion.
- getQ2() - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Get the second coordinate of the vectorial part of the quaternion.
- getQ3() - Method in class org.hipparchus.complex.Quaternion
-
Gets the fourth component of the quaternion (third component
of the vector part).
- getQ3() - Method in class org.hipparchus.geometry.euclidean.threed.FieldRotation
-
Get the third coordinate of the vectorial part of the quaternion.
- getQ3() - Method in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Get the third coordinate of the vectorial part of the quaternion.
- getQT() - Method in class org.hipparchus.linear.FieldQRDecomposition
-
Returns the transpose of the matrix Q of the decomposition.
- getQT() - Method in class org.hipparchus.linear.QRDecomposition
-
Returns the transpose of the matrix Q of the decomposition.
- getQuadraticMean() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the quadratic mean of the available values.
- getQuadraticMean() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the quadratic mean, a.k.a.
- getQuantile() - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Returns the value of the quantile field (determines what percentile is
computed when evaluate() is called with no quantile argument).
- getQuantile() - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
- getQuantileRank(double) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns the estimated quantile position of value in the dataset.
- getR() - Method in class org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
-
Get the radius.
- getR() - Method in class org.hipparchus.linear.FieldQRDecomposition
-
Returns the matrix R of the decomposition.
- getR() - Method in class org.hipparchus.linear.QRDecomposition
-
Returns the matrix R of the decomposition.
- getR() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
- getRadius() - Method in class org.hipparchus.geometry.enclosing.EnclosingBall
-
Get the radius of the ball.
- getRadixDigits() - Method in class org.hipparchus.dfp.Dfp
-
Get the number of radix digits of the instance.
- getRadixDigits() - Method in class org.hipparchus.dfp.DfpField
-
Get the number of radix digits of the
Dfp
instances built by this factory.
- getRandomGenerator() - Method in class org.hipparchus.clustering.FuzzyKMeansClusterer
-
Returns the random generator this instance will use.
- getRandomGenerator() - Method in class org.hipparchus.clustering.KMeansPlusPlusClusterer
-
Returns the random generator this instance will use.
- getRank() - Method in class org.hipparchus.linear.RectangularCholeskyDecomposition
-
Get the rank of the symmetric positive semidefinite matrix.
- getRank() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Return the effective numerical matrix rank.
- getRank() - Method in class org.hipparchus.random.CorrelatedRandomVectorGenerator
-
Get the rank of the covariance matrix.
- getRank(double) - Method in class org.hipparchus.linear.RRQRDecomposition
-
Return the effective numerical matrix rank.
- getRank(double) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Gets the estimated rank of value
, i.e.
- getRankCorrelation() - Method in class org.hipparchus.stat.correlation.SpearmansCorrelation
-
- getRankingThreshold() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LevenbergMarquardtOptimizer
-
Gets the value of a tuning parameter.
- getReal() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.complex.Complex
-
Access the real part.
- getReal() - Method in class org.hipparchus.dfp.Dfp
-
Get the real value of the number.
- getReal() - Method in interface org.hipparchus.RealFieldElement
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.util.Decimal64
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.util.FieldTuple
-
Get the real value of the number.
- getReal() - Method in class org.hipparchus.util.Tuple
-
Get the real value of the number.
- getReal(int) - Method in class org.hipparchus.complex.RootsOfUnity
-
Get the real part of the k
-th n
-th root of unity.
- getRealEigenvalue(int) - Method in class org.hipparchus.linear.EigenDecomposition
-
Returns the real part of the ith eigenvalue of the original
matrix.
- getRealEigenvalues() - Method in class org.hipparchus.linear.EigenDecomposition
-
Gets a copy of the real parts of the eigenvalues of the original matrix.
- getRealFormat() - Method in class org.hipparchus.complex.ComplexFormat
-
Access the realFormat.
- getReducedChiSquare(int) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
-
Get the reduced chi-square.
- getReducedChiSquare(int) - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
-
Get the reduced chi-square.
- getReducedFraction(int, int) - Static method in class org.hipparchus.fraction.BigFraction
-
Creates a BigFraction
instance with the 2 parts of a fraction
Y/Z.
- getReducedFraction(int, int) - Static method in class org.hipparchus.fraction.Fraction
-
Creates a Fraction
instance with the 2 parts
of a fraction Y/Z.
- getRegressionSumSquares() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the sum of squared deviations of the predicted y values about
their mean (which equals the mean of y).
- getRegressionSumSquares() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the predicted y values about
their mean (which equals the mean of y).
- getRelationship() - Method in class org.hipparchus.optim.linear.LinearConstraint
-
Gets the relationship between left and right hand sides.
- getRelativeAccuracy() - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Get the relative accuracy.
- getRelativeAccuracy() - Method in interface org.hipparchus.analysis.integration.UnivariateIntegrator
-
Get the relative accuracy.
- getRelativeAccuracy() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Get the relative accuracy of the solver.
- getRelativeAccuracy() - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Get the relative accuracy of the solver.
- getRelativeAccuracy() - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Get the relative accuracy of the solver.
- getRelativeAccuracy() - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Get the relative accuracy.
- getRelativeThreshold() - Method in class org.hipparchus.optim.AbstractConvergenceChecker
-
- getRemainingRegion() - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Get the remaining region of the hyperplane.
- getResidual() - Method in class org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Returns the residual.
- getResidual() - Method in class org.hipparchus.linear.IterativeLinearSolverEvent
-
Returns the residual.
- getResiduals() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
-
Get the weighted residuals.
- getResult() - Method in class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.moment.Mean
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.moment.Skewness
-
Returns the value of the statistic based on the values that have been added.
- getResult() - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.rank.Max
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.rank.Min
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns an estimate of the median.
- getResult() - Method in interface org.hipparchus.stat.descriptive.StorelessMultivariateStatistic
-
Returns the current value of the Statistic.
- getResult() - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.summary.Product
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.summary.Sum
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Returns the current value of the Statistic.
- getResult() - Method in class org.hipparchus.stat.descriptive.vector.VectorialCovariance
-
Get the covariance matrix.
- getResult() - Method in class org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
-
Returns the current value of the Statistic.
- getResult(double) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
Returns an estimate of the given percentile.
- getReverse() - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get the reverse of the instance.
- getReverse() - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Get the reverse of the instance.
- getReverse() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the reverse of the instance.
- getRightAbscissa() - Method in class org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
-
Get the right abscissa.
- getRightAbscissa() - Method in class org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
-
Get the right abscissa.
- getRightHandSideVector() - Method in class org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Returns the current right-hand side of the linear system to be solved.
- getRightHandSideVector() - Method in class org.hipparchus.linear.IterativeLinearSolverEvent
-
Returns the current right-hand side of the linear system to be solved.
- getRightValue() - Method in class org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
-
- getRightValue() - Method in class org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
-
- getRMS() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
-
Get the normalized cost.
- getRMS() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
-
Get the normalized cost.
- getRootMatrix() - Method in class org.hipparchus.linear.RectangularCholeskyDecomposition
-
Get the root of the covariance matrix.
- getRootMatrix() - Method in class org.hipparchus.random.CorrelatedRandomVectorGenerator
-
Get the root of the covariance matrix.
- getRoundingMode() - Method in class org.hipparchus.dfp.DfpField
-
Get the current rounding mode.
- getRoundingMode() - Method in class org.hipparchus.util.BigReal
-
Gets the rounding mode for division operations
The default is RoundingMode.HALF_UP
- getRow() - Method in exception org.hipparchus.migration.linear.NonPositiveDefiniteMatrixException
-
Deprecated.
- getRow() - Method in exception org.hipparchus.migration.linear.NonSymmetricMatrixException
-
Deprecated.
- getRow(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get the entries in row number row
as an array.
- getRow(int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Get the entries at the given row index.
- getRow(int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Get the entries in row number row
as an array.
- getRow(int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Get the entries at the given row index.
- getRow(int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Get the entries in row number row
as an array.
- getRow(int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Get the entries at the given row index.
- getRow(int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Get the entries in row number row
as an array.
- getRow(int) - Method in interface org.hipparchus.linear.RealMatrix
-
Get the entries at the given row index.
- getRowDimension() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in interface org.hipparchus.linear.AnyMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Returns the number of rows in the matrix.
- getRowDimension() - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in class org.hipparchus.linear.JacobiPreconditioner
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Returns the number of rows of this matrix.
- getRowDimension() - Method in interface org.hipparchus.linear.RealLinearOperator
-
Returns the dimension of the codomain of this operator.
- getRowDimension() - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Returns the number of rows in the matrix.
- getRowMatrix(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get the entries in row number row
as a row matrix.
- getRowMatrix(int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Get the entries at the given row index as a row matrix.
- getRowMatrix(int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Get the entries in row number row
as a row matrix.
- getRowMatrix(int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Get the entries at the given row index as a row matrix.
- getRowMatrix(int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Get the entries in row number row
as a row matrix.
- getRowMatrix(int) - Method in interface org.hipparchus.linear.RealMatrix
-
Get the entries at the given row index as a row matrix.
- getRowPrefix() - Method in class org.hipparchus.linear.RealMatrixFormat
-
Get the format prefix.
- getRowSeparator() - Method in class org.hipparchus.linear.RealMatrixFormat
-
Get the format separator between rows of the matrix.
- getRowSuffix() - Method in class org.hipparchus.linear.RealMatrixFormat
-
Get the format suffix.
- getRowVector(int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get the entries in row number row
as a vector.
- getRowVector(int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the entries in row number row
as a vector.
- getRowVector(int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Get the entries in row number row
as a vector.
- getRowVector(int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the entries in row number row
as a vector.
- getRowVector(int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Get the entries in row number row
as a vector.
- getRowVector(int) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the entries in row number row
as a vector.
- getRSquare() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
- getRSquared() - Method in class org.hipparchus.stat.regression.RegressionResults
-
- getRule(int) - Method in class org.hipparchus.analysis.integration.gauss.BaseRuleFactory
-
Gets a copy of the quadrature rule with the given number of integration
points.
- getRuleInternal(int) - Method in class org.hipparchus.analysis.integration.gauss.BaseRuleFactory
-
Gets a rule.
- getRuntimeClass() - Method in class org.hipparchus.complex.ComplexField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.dfp.DfpField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in interface org.hipparchus.Field
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.fraction.BigFractionField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.fraction.FractionField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.util.BigRealField
-
Returns the runtime class of the FieldElement.
- getRuntimeClass() - Method in class org.hipparchus.util.Decimal64Field
-
Returns the runtime class of the FieldElement.
- getS() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Returns the diagonal matrix Σ of the decomposition.
- getSafety() - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Get the safety factor for stepsize control.
- getSafety() - Method in class org.hipparchus.ode.MultistepIntegrator
-
Get the safety factor for stepsize control.
- getSafety() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Get the safety factor for stepsize control.
- getSafety() - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Get the safety factor for stepsize control.
- getSampleSize() - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
Access the sample size.
- getSampleStats() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
- getScalarPart() - Method in class org.hipparchus.complex.Quaternion
-
Gets the scalar part of the quaternion.
- getScale() - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
Access the scale parameter.
- getScale() - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
Returns the scale parameter of this
distribution.
- getScale() - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
Access the scale parameter, beta
.
- getScale() - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Access the scale parameter, beta
.
- getScale() - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Get the scale parameter of the distribution.
- getScale() - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
Access the scale parameter, s
.
- getScale() - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Returns the scale parameter of this distribution.
- getScale() - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Access the scale parameter, omega
.
- getScale() - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
Returns the scale parameter of this distribution.
- getScale() - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Access the scale parameter, beta
.
- getScale() - Method in class org.hipparchus.util.BigReal
-
Sets the scale for division operations.
- getSecond() - Method in class org.hipparchus.util.Pair
-
Get the second element of the pair.
- getSecondaryDerivative(int) - Method in class org.hipparchus.ode.FieldODEStateAndDerivative
-
Get derivative of the secondary state at time.
- getSecondaryDerivative(int) - Method in class org.hipparchus.ode.ODEStateAndDerivative
-
Get derivative of the secondary state at time.
- getSecondaryState(int) - Method in class org.hipparchus.ode.FieldODEState
-
Get secondary state at time.
- getSecondaryState(int) - Method in class org.hipparchus.ode.ODEState
-
Get secondary state at time.
- getSecondaryStateDimension(int) - Method in class org.hipparchus.ode.FieldODEState
-
Get secondary state dimension.
- getSecondaryStateDimension(int) - Method in class org.hipparchus.ode.ODEState
-
Get secondary state dimension.
- getSecondMoment() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns a statistic related to the Second Central Moment.
- getSegments() - Method in class org.hipparchus.geometry.euclidean.threed.SubLine
-
Get the endpoints of the sub-line.
- getSegments() - Method in class org.hipparchus.geometry.euclidean.twod.SubLine
-
Get the endpoints of the sub-line.
- getSeparator() - Method in class org.hipparchus.geometry.VectorFormat
-
Get the format separator between components.
- getSeparator() - Method in class org.hipparchus.linear.RealVectorFormat
-
Get the format separator between components.
- getShape() - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
Returns the shape parameter of this
distribution.
- getShape() - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Returns the shape parameter of this distribution.
- getShape() - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Access the shape parameter, mu
.
- getShape() - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
Returns the shape parameter of this distribution.
- getShape() - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Access the shape parameter, alpha
.
- getSide() - Method in class org.hipparchus.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Get the side of the split sub-hyperplane with respect to its splitter.
- getSide() - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet.Split
-
Get the side of the split arc with respect to its splitter.
- getSide(AllowedSolution) - Method in class org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
-
Get the abscissa corresponding to the allowed side.
- getSide(AllowedSolution) - Method in class org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
-
Get the abscissa corresponding to the allowed side.
- getSigma() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer.Sigma
-
- getSigma(double) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.AbstractEvaluation
-
Get an estimate of the standard deviation of the parameters.
- getSigma(double) - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem.Evaluation
-
Get an estimate of the standard deviation of the parameters.
- getSignificance() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the significance level of the slope (equiv) correlation.
- getSingularValues() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Returns the diagonal elements of the matrix Σ of the decomposition.
- getSize() - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Get the array size required for holding partial derivatives data.
- getSize() - Method in class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Get the size of the sphere.
- getSize() - Method in class org.hipparchus.geometry.euclidean.oned.Interval
-
Get the size of the interval.
- getSize() - Method in class org.hipparchus.geometry.euclidean.oned.SubOrientedPoint
-
Get the size of the instance.
- getSize() - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Get the size of the instance.
- getSize() - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Get the size of the instance.
- getSize() - Method in interface org.hipparchus.geometry.partitioning.Region
-
Get the size of the instance.
- getSize() - Method in interface org.hipparchus.geometry.partitioning.SubHyperplane
-
Get the size of the instance.
- getSize() - Method in class org.hipparchus.geometry.spherical.oned.Arc
-
Get the angular size of the arc.
- getSize() - Method in class org.hipparchus.geometry.spherical.oned.SubLimitAngle
-
Get the size of the instance.
- getSize() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Get simplex size.
- getSize() - Method in class org.hipparchus.util.MultidimensionalCounter
-
Get the total number of elements.
- getSizes() - Method in class org.hipparchus.util.MultidimensionalCounter
-
Get the number of multidimensional counter slots in each dimension.
- getSkewness() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the skewness of the available values.
- getSlope() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the slope of the estimated regression line.
- getSlopeConfidenceInterval() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the half-width of a 95% confidence interval for the slope
estimate.
- getSlopeConfidenceInterval(double) - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the half-width of a (100-100*alpha)% confidence interval for
the slope estimate.
- getSlopeStdErr() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
- getSolution() - Method in class org.hipparchus.linear.DefaultIterativeLinearSolverEvent
-
Returns the current estimate of the solution to the linear system to be
solved.
- getSolution() - Method in class org.hipparchus.linear.IterativeLinearSolverEvent
-
Returns the current estimate of the solution to the linear system to be
solved.
- getSolution() - Method in class org.hipparchus.optim.linear.SolutionCallback
-
Retrieve the best solution found so far.
- getSolver() - Method in class org.hipparchus.linear.CholeskyDecomposition
-
Get a solver for finding the A × X = B solution in least square sense.
- getSolver() - Method in class org.hipparchus.linear.EigenDecomposition
-
Gets a solver for finding the A × X = B solution in exact
linear sense.
- getSolver() - Method in class org.hipparchus.linear.FieldLUDecomposition
-
Get a solver for finding the A × X = B solution in exact linear sense.
- getSolver() - Method in class org.hipparchus.linear.FieldQRDecomposition
-
Get a solver for finding the A × X = B solution in least square sense.
- getSolver() - Method in class org.hipparchus.linear.LUDecomposition
-
Get a solver for finding the A × X = B solution in exact linear
sense.
- getSolver() - Method in class org.hipparchus.linear.QRDecomposition
-
Get a solver for finding the A × X = B solution in least square sense.
- getSolver() - Method in class org.hipparchus.linear.RRQRDecomposition
-
Get a solver for finding the A × X = B solution in least square sense.
- getSolver() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Get a solver for finding the A × X = B solution in least square sense.
- getSolverAbsoluteAccuracy() - Method in class org.hipparchus.distribution.continuous.AbstractRealDistribution
-
Returns the solver absolute accuracy for inverse cumulative computation.
- getSortedValues() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the current set of values in an array of double primitives,
sorted in ascending order.
- getSourceString() - Method in enum org.hipparchus.clustering.LocalizedClusteringFormats
-
Gets the source (non-localized) string.
- getSourceString() - Method in class org.hipparchus.exception.DummyLocalizable
-
Gets the source (non-localized) string.
- getSourceString() - Method in interface org.hipparchus.exception.Localizable
-
Gets the source (non-localized) string.
- getSourceString() - Method in enum org.hipparchus.exception.LocalizedCoreFormats
-
Gets the source (non-localized) string.
- getSourceString() - Method in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
Gets the source (non-localized) string.
- getSourceString() - Method in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
Gets the source (non-localized) string.
- getSourceString() - Method in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
Gets the source (non-localized) string.
- getSourceString() - Method in enum org.hipparchus.ode.LocalizedODEFormats
-
Gets the source (non-localized) string.
- getSourceString() - Method in enum org.hipparchus.optim.LocalizedOptimFormats
-
Gets the source (non-localized) string.
- getSourceString() - Method in enum org.hipparchus.stat.LocalizedStatFormats
-
Gets the source (non-localized) string.
- getSourceString() - Method in enum org.hipparchus.transform.LocalizedFFTFormats
-
Gets the source (non-localized) string.
- getSpace() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get the space to which the point belongs.
- getSpace() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the space to which the point belongs.
- getSpace() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the space to which the point belongs.
- getSpace() - Method in interface org.hipparchus.geometry.Point
-
Get the space to which the point belongs.
- getSpace() - Method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Get the space to which the point belongs.
- getSpace() - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Get the space to which the point belongs.
- getSparsity() - Method in class org.hipparchus.linear.OpenMapRealVector
-
- getSpecifier() - Method in interface org.hipparchus.exception.LocalizedException
-
Get the localizable specifier of the error message.
- getSpecifier() - Method in exception org.hipparchus.exception.MathRuntimeException
-
Get the localizable specifier of the error message.
- getSpecifier() - Method in exception org.hipparchus.exception.NullArgumentException
-
Get the localizable specifier of the error message.
- getSplitters() - Method in class org.hipparchus.geometry.partitioning.BoundaryAttribute
-
Get the sub-hyperplanes that were used to split the boundary part.
- getSqr2() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant √2.
- getSqr2Reciprocal() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant √2 / 2.
- getSqr2Split() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant √2 split in two pieces.
- getSqr3() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant √3.
- getSqr3Reciprocal() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant √3 / 3.
- getSquareRoot() - Method in class org.hipparchus.linear.EigenDecomposition
-
Computes the square-root of the matrix.
- getStandardDeviation() - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Access the standard deviation.
- getStandardDeviation() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
- getStandardDeviation() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
standard deviation of the ith entries of the arrays
that correspond to each multivariate sample
- getStandardDeviation() - Method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
Returns the standard deviation of the available values.
- getStandardDeviation() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
- getStandardDeviation() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the standard deviation of the values that have been added.
- getStandardDeviations() - Method in class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Gets the square root of each element on the diagonal of the covariance
matrix.
- getStart() - Method in class org.hipparchus.geometry.euclidean.threed.Segment
-
Get the start point of the segment.
- getStart() - Method in class org.hipparchus.geometry.euclidean.twod.Segment
-
Get the start point of the segment.
- getStart() - Method in class org.hipparchus.geometry.spherical.twod.Edge
-
Get start vertex.
- getStart() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresAdapter
-
Gets the initial guess.
- getStart() - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresProblem
-
Gets the initial guess.
- getStarterIntegrator() - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Get the starter integrator.
- getStarterIntegrator() - Method in class org.hipparchus.ode.MultistepIntegrator
-
Get the starter integrator.
- getStartIndex() - Method in class org.hipparchus.util.ResizableDoubleArray
-
Returns the "start index" of the internal array.
- getStartPoint() - Method in class org.hipparchus.optim.BaseMultivariateOptimizer
-
Gets the initial guess.
- getStartValue() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
- getStartValue() - Method in class org.hipparchus.optim.univariate.SearchInterval
-
Gets the start value.
- getStartValue() - Method in class org.hipparchus.optim.univariate.UnivariateOptimizer
-
- getState() - Method in class org.hipparchus.filtering.kalman.ProcessEstimate
-
Get the state vector.
- getState() - Method in class org.hipparchus.ode.FieldODEState
-
- getStateDimension() - Method in class org.hipparchus.ode.FieldODEState
-
- getStateTransitionMatrix() - Method in class org.hipparchus.filtering.kalman.extended.NonLinearEvolution
-
Get state transition matrix between previous and current state.
- getStateTransitionMatrix() - Method in class org.hipparchus.filtering.kalman.linear.LinearEvolution
-
Get the state transition matrix Ak-1.
- getStatisticsDHistory() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- getStatisticsFitnessHistory() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- getStatisticsMeanHistory() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- getStatisticsSigmaHistory() - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer
-
- getStdErrorOfEstimate(int) - Method in class org.hipparchus.stat.regression.RegressionResults
-
- getStdErrorOfEstimates() - Method in class org.hipparchus.stat.regression.RegressionResults
-
- getStepHandlers() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get all the step handlers that have been added to the integrator.
- getStepHandlers() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get all the step handlers that have been added to the integrator.
- getStepHandlers() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Get all the step handlers that have been added to the integrator.
- getStepHandlers() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Get all the step handlers that have been added to the integrator.
- getStepSize() - Method in class org.hipparchus.analysis.differentiation.FiniteDifferencesDifferentiator
-
Get the step size.
- getStepSize() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get the current step size.
- getStepSize() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get the current step size.
- getStepStart() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Get the state at step start time ti.
- getStepStart() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Get the state at step start time ti.
- getStepStart() - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Get the state at step start time ti.
- getStepStart() - Method in interface org.hipparchus.ode.ODEIntegrator
-
Get the state at step start time ti.
- getStopTime() - Method in class org.hipparchus.ode.events.EventState.EventOccurrence
-
Get the new time for a stop action.
- getStopTime() - Method in class org.hipparchus.ode.events.FieldEventState.EventOccurrence
-
Get the new time for a stop action.
- getStrict() - Method in exception org.hipparchus.migration.exception.NonMonotonicSequenceException
-
Deprecated.
- getSubMatrix(int[], int[]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get a submatrix.
- getSubMatrix(int[], int[]) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Gets a submatrix.
- getSubMatrix(int[], int[]) - Method in interface org.hipparchus.linear.FieldMatrix
-
Get a submatrix.
- getSubMatrix(int[], int[]) - Method in interface org.hipparchus.linear.RealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int, int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int, int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Gets a submatrix.
- getSubMatrix(int, int, int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Get a submatrix.
- getSubMatrix(int, int, int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Gets a submatrix.
- getSubSpace() - Method in class org.hipparchus.geometry.euclidean.oned.Euclidean1D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in class org.hipparchus.geometry.euclidean.threed.Euclidean3D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in class org.hipparchus.geometry.euclidean.twod.Euclidean2D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in interface org.hipparchus.geometry.Space
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in class org.hipparchus.geometry.spherical.oned.Sphere1D
-
Get the n-1 dimension subspace of this space.
- getSubSpace() - Method in class org.hipparchus.geometry.spherical.twod.Sphere2D
-
Get the n-1 dimension subspace of this space.
- getSubVector(int, int) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class org.hipparchus.linear.ArrayRealVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in interface org.hipparchus.linear.FieldVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class org.hipparchus.linear.RealVector
-
Get a subvector from consecutive elements.
- getSubVector(int, int) - Method in class org.hipparchus.linear.SparseFieldVector
-
Get a subvector from consecutive elements.
- getSuffix() - Method in class org.hipparchus.geometry.VectorFormat
-
Get the format suffix.
- getSuffix() - Method in class org.hipparchus.linear.RealMatrixFormat
-
Get the format suffix.
- getSuffix() - Method in class org.hipparchus.linear.RealVectorFormat
-
Get the format suffix.
- getSum() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the sum of the values that have been added to Univariate.
- getSum() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns an array whose ith entry is the
sum of the ith entries of the arrays
that correspond to each multivariate sample
- getSum() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
sum of the ith entries of the arrays
that correspond to each multivariate sample
- getSum() - Method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
Returns the sum of the values that have been added to Univariate.
- getSum() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
- getSum() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the sum of the values that have been added to Univariate.
- getSumFreq() - Method in class org.hipparchus.stat.Frequency
-
Returns the sum of all frequencies.
- getSumLog() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns an array whose ith entry is the
sum of logs of the ith entries of the arrays
that correspond to each multivariate sample
- getSumLog() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
sum of logs of the ith entries of the arrays
that correspond to each multivariate sample
- getSummary() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
- getSumOfCrossProducts() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the sum of crossproducts, xi*yi.
- getSumOfLogs() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the sum of the logs of the values that have been added.
- getSumOfSquares() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the sum of the squares of the available values.
- getSumOfSquares() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the sum of the squares of the values that have been added.
- getSumSq() - Method in class org.hipparchus.stat.descriptive.MultivariateSummaryStatistics
-
Returns an array whose ith entry is the
sum of squares of the ith entries of the arrays
that correspond to each multivariate sample
- getSumSq() - Method in interface org.hipparchus.stat.descriptive.StatisticalMultivariateSummary
-
Returns an array whose ith entry is the
sum of squares of the ith entries of the arrays
that correspond to each multivariate sample
- getSumSquaredErrors() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
- getSup() - Method in class org.hipparchus.geometry.euclidean.oned.Interval
-
Get the upper bound of the interval.
- getSup() - Method in class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Get the highest value belonging to the instance.
- getSup() - Method in class org.hipparchus.geometry.spherical.oned.Arc
-
Get the upper angular bound of the arc.
- getSupport() - Method in class org.hipparchus.geometry.enclosing.EnclosingBall
-
Get the support points used to define the ball.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.FDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.TDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.UniformRealDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.discrete.UniformIntegerDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in interface org.hipparchus.distribution.IntegerDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in interface org.hipparchus.distribution.RealDistribution
-
Access the lower bound of the support.
- getSupportLowerBound() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Access the lower bound of the support.
- getSupportSize() - Method in class org.hipparchus.geometry.enclosing.EnclosingBall
-
Get the number of support points used to define the ball.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.FDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.TDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.UniformRealDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.discrete.UniformIntegerDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in interface org.hipparchus.distribution.IntegerDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in interface org.hipparchus.distribution.RealDistribution
-
Access the upper bound of the support.
- getSupportUpperBound() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Access the upper bound of the support.
- getTheta() - Method in class org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
-
Get the azimuthal angle in x-y plane.
- getTheta() - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Get the azimuthal angle \( \theta \) in the x-y plane.
- getThreshold() - Method in exception org.hipparchus.migration.linear.NonPositiveDefiniteMatrixException
-
Deprecated.
- getThreshold() - Method in exception org.hipparchus.migration.linear.NonSymmetricMatrixException
-
Deprecated.
- getTiesStrategy() - Method in class org.hipparchus.stat.ranking.NaturalRanking
-
Return the TiesStrategy
- getTime() - Method in interface org.hipparchus.filtering.kalman.Measurement
-
Get the process time.
- getTime() - Method in class org.hipparchus.filtering.kalman.ProcessEstimate
-
Get the process time.
- getTime() - Method in class org.hipparchus.ode.FieldODEState
-
Get time.
- getTime() - Method in class org.hipparchus.ode.ODEState
-
Get time.
- getTolerance() - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Get the tolerance below which points are considered to belong to the hyperplane.
- getTolerance() - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Get the tolerance below which points are considered identical.
- getTolerance() - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Get the tolerance below which points are considered identical.
- getTolerance() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the tolerance below which points are considered to belong to the hyperplane.
- getTolerance() - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get the tolerance below which points are considered to belong to the hyperplane.
- getTolerance() - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Get the tolerance below which points are considered to belong to hyperplanes.
- getTolerance() - Method in interface org.hipparchus.geometry.partitioning.Hyperplane
-
Get the tolerance below which points are considered to belong to the hyperplane.
- getTolerance() - Method in class org.hipparchus.geometry.spherical.oned.Arc
-
Get the tolerance below which angles are considered identical.
- getTolerance() - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Get the tolerance below which points are considered to belong to the hyperplane.
- getTolerance() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the tolerance below which points are considered to belong to the hyperplane.
- getTotalDimension() - Method in class org.hipparchus.ode.EquationsMapper
-
Return the dimension of the complete set of equations.
- getTotalDimension() - Method in class org.hipparchus.ode.FieldEquationsMapper
-
Return the dimension of the complete set of equations.
- getTotalSumSquares() - Method in class org.hipparchus.stat.regression.RegressionResults
-
Returns the sum of squared deviations of the y values about their mean.
- getTotalSumSquares() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the y values about their mean.
- getTrace() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTrace() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTrace() - Method in interface org.hipparchus.linear.FieldMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTrace() - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the
trace of the matrix (the sum of the elements on the main diagonal).
- getTransform(double, double, double, double, double, double) - Static method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get a
Transform
embedding an affine transform.
- getTransform(Rotation) - Static method in class org.hipparchus.geometry.spherical.twod.Circle
-
- getTree(boolean) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Get the underlying BSP tree.
- getTree(boolean) - Method in interface org.hipparchus.geometry.partitioning.Region
-
Get the underlying BSP tree.
- getTriggeredIncreasing() - Method in enum org.hipparchus.ode.events.FilterType
-
Get the increasing status of triggered events.
- getTwo() - Method in class org.hipparchus.dfp.Dfp
-
Get the constant 2.
- getTwo() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant 2.
- getU() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the plane first canonical vector.
- getU() - Method in class org.hipparchus.linear.FieldLUDecomposition
-
Returns the matrix U of the decomposition.
- getU() - Method in class org.hipparchus.linear.LUDecomposition
-
Returns the matrix U of the decomposition.
- getU() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Returns the matrix U of the decomposition.
- getUniqueCount() - Method in class org.hipparchus.stat.Frequency
-
Returns the number of values in the frequency table.
- getUpper() - Method in class org.hipparchus.optim.SimpleBounds
-
Gets the upper bounds.
- getUpperBound() - Method in class org.hipparchus.optim.BaseMultivariateOptimizer
-
- getUpperBound() - Method in class org.hipparchus.stat.interval.ConfidenceInterval
-
- getUpperBounds() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Returns a fresh copy of the array of upper bounds for the bins.
- getUT() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Returns the transpose of the matrix U of the decomposition.
- getV() - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the plane second canonical vector.
- getV() - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Getter V.
- getV() - Method in class org.hipparchus.linear.EigenDecomposition
-
Gets the matrix V of the decomposition.
- getV() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Returns the matrix V of the decomposition.
- getVals() - Method in class org.hipparchus.special.BesselJ.BesselJResult
-
- getValue() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Get the value part of the derivative structure.
- getValue() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Get the value part of the derivative structure.
- getValue() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Get the value of the function.
- getValue() - Method in interface org.hipparchus.filtering.kalman.Measurement
-
Get the measurement vector.
- getValue() - Method in class org.hipparchus.linear.OpenMapRealVector.OpenMapEntry
-
Get the value of the entry.
- getValue() - Method in class org.hipparchus.linear.RealVector.Entry
-
Get the value of the entry.
- getValue() - Method in class org.hipparchus.optim.linear.LinearConstraint
-
Gets the value of the constraint (right hand side).
- getValue() - Method in class org.hipparchus.optim.PointVectorValuePair
-
Gets the value of the objective function.
- getValue() - Method in class org.hipparchus.optim.univariate.UnivariatePointValuePair
-
Get the value of the objective function.
- getValue() - Method in class org.hipparchus.util.Pair
-
Get the value.
- getValueField() - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
Get the
Field
the value and parameters of the function belongs to.
- getValueRef() - Method in class org.hipparchus.optim.PointVectorValuePair
-
Gets a reference to the value of the objective function.
- getValues() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the current set of values in an array of double primitives.
- getVariance() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the variance of the available values.
- getVariance() - Method in interface org.hipparchus.stat.descriptive.StatisticalSummary
-
Returns the variance of the available values.
- getVariance() - Method in class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
- getVariance() - Method in class org.hipparchus.stat.descriptive.StreamingStatistics
-
Returns the variance of the available values.
- getVarianceDirection() - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns the varianceDirection property.
- getVector() - Method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Get the corresponding normalized vector in the 2D euclidean space.
- getVector() - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Get the corresponding normalized vector in the 3D euclidean space.
- getVectorPart() - Method in class org.hipparchus.complex.Quaternion
-
Gets the three components of the vector part of the quaternion.
- getVertices() - Method in class org.hipparchus.geometry.euclidean.threed.PolyhedronsSet.BRep
-
Get the extracted vertices.
- getVertices() - Method in class org.hipparchus.geometry.euclidean.twod.hull.ConvexHull2D
-
Get the vertices of the convex hull.
- getVertices() - Method in class org.hipparchus.geometry.euclidean.twod.PolygonsSet
-
Get the vertices of the polygon.
- getVertices() - Method in interface org.hipparchus.geometry.hull.ConvexHull
-
Get the vertices of the convex hull.
- getVT() - Method in class org.hipparchus.linear.ComplexEigenDecomposition
-
Getter VT.
- getVT() - Method in class org.hipparchus.linear.EigenDecomposition
-
Gets the transpose of the matrix V of the decomposition.
- getVT() - Method in class org.hipparchus.linear.OrderedComplexEigenDecomposition
-
Getter VT.
- getVT() - Method in class org.hipparchus.linear.OrderedEigenDecomposition
-
Gets the transpose of the matrix V of the decomposition.
- getVT() - Method in class org.hipparchus.linear.SingularValueDecomposition
-
Returns the transpose of the matrix V of the decomposition.
- getWeight() - Method in class org.hipparchus.fitting.WeightedObservedPoint
-
Gets the weight of the measurement in the fitting process.
- getWeight(int) - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegrator
-
Gets the weight of the integration point at the given index.
- getWholeFormat() - Method in class org.hipparchus.fraction.ProperBigFractionFormat
-
Access the whole format.
- getWholeFormat() - Method in class org.hipparchus.fraction.ProperFractionFormat
-
Access the whole format.
- getWilsonScoreInterval(int, double, double) - Static method in class org.hipparchus.stat.interval.BinomialProportion
-
Create an Wilson score binomial confidence interval for the true
probability of success of an unknown binomial distribution with
the given observed number of trials, probability of success and
confidence level.
- getWindowSize() - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Returns the maximum number of values that can be stored in the
dataset, or INFINITE_WINDOW (-1) if there is no limit.
- getWorkArray(double[], int, int) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Get the work array to operate.
- getWrongColumnDimension() - Method in exception org.hipparchus.migration.linear.MatrixDimensionMismatchException
-
Deprecated.
- getWrongDimension(int) - Method in exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.
- getWrongDimensions() - Method in exception org.hipparchus.migration.exception.MultiDimensionMismatchException
-
Deprecated.
- getWrongRowDimension() - Method in exception org.hipparchus.migration.linear.MatrixDimensionMismatchException
-
Deprecated.
- getX() - Method in class org.hipparchus.fitting.WeightedObservedPoint
-
Gets the abscissa of the point.
- getX() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get the abscissa of the vector.
- getX() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the abscissa of the vector.
- getX() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the abscissa of the vector.
- getX() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the abscissa of the vector.
- getX() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
- getXAxis() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the X axis of the circle.
- getXSumSquares() - Method in class org.hipparchus.stat.regression.SimpleRegression
-
Returns the sum of squared deviations of the x values about their mean.
- getY() - Method in class org.hipparchus.fitting.WeightedObservedPoint
-
Gets the observed value of the function at x.
- getY() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the ordinate of the vector.
- getY() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the ordinate of the vector.
- getY() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the ordinate of the vector.
- getY() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
- getYAxis() - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Get the Y axis of the circle.
- getZ() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get the height of the vector.
- getZ() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the height of the vector.
- getZero() - Method in class org.hipparchus.complex.ComplexField
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.dfp.Dfp
-
Get the constant 0.
- getZero() - Method in class org.hipparchus.dfp.DfpField
-
Get the constant 0.
- getZero() - Method in interface org.hipparchus.Field
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.fraction.BigFractionField
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.fraction.FractionField
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in interface org.hipparchus.geometry.Vector
-
Get the null vector of the vectorial space or origin point of the affine space.
- getZero() - Method in class org.hipparchus.util.BigRealField
-
Get the additive identity of the field.
- getZero() - Method in class org.hipparchus.util.Decimal64Field
-
Get the additive identity of the field.
- getZero(Field<T>) - Static method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Get null vector (coordinates: 0, 0, 0).
- GillFieldIntegrator<T extends RealFieldElement<T>> - Class in org.hipparchus.ode.nonstiff
-
This class implements the Gill fourth order Runge-Kutta
integrator for Ordinary Differential Equations .
- GillFieldIntegrator(Field<T>, T) - Constructor for class org.hipparchus.ode.nonstiff.GillFieldIntegrator
-
Simple constructor.
- GillIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements the Gill fourth order Runge-Kutta
integrator for Ordinary Differential Equations .
- GillIntegrator(double) - Constructor for class org.hipparchus.ode.nonstiff.GillIntegrator
-
Simple constructor.
- GLSMultipleLinearRegression - Class in org.hipparchus.stat.regression
-
The GLS implementation of multiple linear regression.
- GLSMultipleLinearRegression() - Constructor for class org.hipparchus.stat.regression.GLSMultipleLinearRegression
-
- GoalType - Enum in org.hipparchus.optim.nonlinear.scalar
-
Goal type for an optimization problem (minimization or maximization of
a scalar function.
- gradient(double, double...) - Method in class org.hipparchus.analysis.function.Gaussian.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in class org.hipparchus.analysis.function.HarmonicOscillator.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in class org.hipparchus.analysis.function.Logistic.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in class org.hipparchus.analysis.function.Logit.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in class org.hipparchus.analysis.function.Sigmoid.Parametric
-
Computes the value of the gradient at x
.
- gradient(double, double...) - Method in interface org.hipparchus.analysis.ParametricUnivariateFunction
-
Compute the gradient of the function with respect to its parameters.
- gradient(double, double...) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction.Parametric
-
Compute the gradient of the function with respect to its parameters.
- GradientFunction - Class in org.hipparchus.analysis.differentiation
-
Class representing the gradient of a multivariate function.
- GradientFunction(MultivariateDifferentiableFunction) - Constructor for class org.hipparchus.analysis.differentiation.GradientFunction
-
Simple constructor.
- GradientMultivariateOptimizer - Class in org.hipparchus.optim.nonlinear.scalar
-
Base class for implementing optimizers for multivariate scalar
differentiable functions.
- GradientMultivariateOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.hipparchus.optim.nonlinear.scalar.GradientMultivariateOptimizer
-
- GraggBulirschStoerIntegrator - Class in org.hipparchus.ode.nonstiff
-
This class implements a Gragg-Bulirsch-Stoer integrator for
Ordinary Differential Equations.
- GraggBulirschStoerIntegrator(double, double, double[], double[]) - Constructor for class org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
-
Simple constructor.
- GraggBulirschStoerIntegrator(double, double, double, double) - Constructor for class org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
-
Simple constructor.
- GREATER_THAN - org.hipparchus.stat.inference.AlternativeHypothesis
-
Represents a right-sided test.
- greaterThan(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is greater than x.
- gTest(double[], long[]) - Method in class org.hipparchus.stat.inference.GTest
-
Returns the
observed significance level, or
p-value,
associated with a G-Test for goodness of fit comparing the
observed
frequency counts to those in the
expected
array.
- gTest(double[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- gTest(double[], long[], double) - Method in class org.hipparchus.stat.inference.GTest
-
Performs a G-Test (Log-Likelihood Ratio Test) for goodness of fit
evaluating the null hypothesis that the observed counts conform to the
frequency distribution described by the expected counts, with
significance level alpha
.
- gTest(double[], long[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- GTest - Class in org.hipparchus.stat.inference
-
- GTest() - Constructor for class org.hipparchus.stat.inference.GTest
-
- gTestDataSetsComparison(long[], long[]) - Method in class org.hipparchus.stat.inference.GTest
-
Returns the
observed significance level, or
p-value, associated with a G-Value (Log-Likelihood Ratio) for two
sample test comparing bin frequency counts in
observed1
and
observed2
.
- gTestDataSetsComparison(long[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- gTestDataSetsComparison(long[], long[], double) - Method in class org.hipparchus.stat.inference.GTest
-
Performs a G-Test (Log-Likelihood Ratio Test) comparing two binned
data sets.
- gTestDataSetsComparison(long[], long[], double) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- gTestIntrinsic(double[], long[]) - Method in class org.hipparchus.stat.inference.GTest
-
Returns the intrinsic (Hardy-Weinberg proportions) p-Value, as described
in p64-69 of McDonald, J.H.
- gTestIntrinsic(double[], long[]) - Static method in class org.hipparchus.stat.inference.InferenceTestUtils
-
- guess() - Method in class org.hipparchus.fitting.GaussianCurveFitter.ParameterGuesser
-
Gets an estimation of the parameters.
- guess() - Method in class org.hipparchus.fitting.HarmonicCurveFitter.ParameterGuesser
-
Gets an estimation of the parameters.
- GumbelDistribution - Class in org.hipparchus.distribution.continuous
-
This class implements the Gumbel distribution.
- GumbelDistribution(double, double) - Constructor for class org.hipparchus.distribution.continuous.GumbelDistribution
-
Build a new instance.
- I - Static variable in class org.hipparchus.complex.Complex
-
The square root of -1.
- I - Static variable in class org.hipparchus.complex.Quaternion
-
i
- Identity - Class in org.hipparchus.analysis.function
-
Identity function.
- Identity() - Constructor for class org.hipparchus.analysis.function.Identity
-
- IDENTITY - Static variable in class org.hipparchus.complex.Quaternion
-
Identity quaternion.
- IDENTITY - Static variable in class org.hipparchus.geometry.euclidean.threed.Rotation
-
Identity rotation.
- IdentityPreconditioner() - Constructor for class org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.IdentityPreconditioner
-
- IEEEremainder(double, double) - Static method in class org.hipparchus.util.FastMath
-
Computes the remainder as prescribed by the IEEE 754 standard.
- IEEEremainder(T, double) - Static method in class org.hipparchus.util.FastMath
-
Computes the remainder as prescribed by the IEEE 754 standard.
- IEEEremainder(T, T) - Static method in class org.hipparchus.util.FastMath
-
Computes the remainder as prescribed by the IEEE 754 standard.
- ILL_CONDITIONED_OPERATOR - org.hipparchus.exception.LocalizedCoreFormats
-
- ILL_CONDITIONED_OPERATOR - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- IllConditionedOperatorException - Exception in org.hipparchus.migration.linear
-
- IllConditionedOperatorException(double) - Constructor for exception org.hipparchus.migration.linear.IllConditionedOperatorException
-
Deprecated.
Creates a new instance of this class.
- ILLEGAL_STATE - org.hipparchus.exception.LocalizedCoreFormats
-
- ILLEGAL_STATE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ILLINOIS - org.hipparchus.analysis.solvers.BaseSecantSolver.Method
-
- IllinoisSolver - Class in org.hipparchus.analysis.solvers
-
Implements the Illinois method for root-finding (approximating
a zero of a univariate real function).
- IllinoisSolver() - Constructor for class org.hipparchus.analysis.solvers.IllinoisSolver
-
Construct a solver with default accuracy (1e-6).
- IllinoisSolver(double) - Constructor for class org.hipparchus.analysis.solvers.IllinoisSolver
-
Construct a solver.
- IllinoisSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.IllinoisSolver
-
Construct a solver.
- IllinoisSolver(double, double, double) - Constructor for class org.hipparchus.analysis.solvers.IllinoisSolver
-
Construct a solver.
- ImageClusteringExample - Class in org.hipparchus.samples.clustering
-
This example shows how clustering can be applied to images.
- ImageClusteringExample() - Constructor for class org.hipparchus.samples.clustering.ImageClusteringExample
-
- ImageClusteringExample.Display - Class in org.hipparchus.samples.clustering
-
- IMAGINARY_FORMAT - org.hipparchus.exception.LocalizedCoreFormats
-
- IMAGINARY_FORMAT - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- incMoment - Variable in class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Determines whether or not this statistic can be incremented or cleared.
- incMoment - Variable in class org.hipparchus.stat.descriptive.moment.Mean
-
Determines whether or not this statistic can be incremented or cleared.
- incMoment - Variable in class org.hipparchus.stat.descriptive.moment.Skewness
-
Determines whether or not this statistic can be incremented or cleared.
- incMoment - Variable in class org.hipparchus.stat.descriptive.moment.Variance
-
- INCONSISTENT_STATE_AT_2_PI_WRAPPING - org.hipparchus.geometry.LocalizedGeometryFormats
-
- INCONSISTENT_STATE_AT_2_PI_WRAPPING - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- InconsistentStateAt2PiWrapping() - Constructor for exception org.hipparchus.geometry.spherical.oned.ArcsSet.InconsistentStateAt2PiWrapping
-
Simple constructor.
- INCREASING - org.hipparchus.util.MathArrays.OrderDirection
-
Constant for increasing direction.
- increment() - Method in class org.hipparchus.util.Incrementor
-
Adds the increment value to the current iteration count.
- increment(double) - Method in class org.hipparchus.stat.descriptive.AbstractStorelessUnivariateStatistic
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.moment.GeometricMean
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.moment.Kurtosis
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.moment.Mean
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.moment.Skewness
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.rank.Max
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.rank.Min
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.rank.PSquarePercentile
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.rank.RandomPercentile
-
- increment(double) - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.summary.Product
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.summary.Sum
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double) - Method in class org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Updates the internal state of the statistic to reflect the addition of the new value.
- increment(double[]) - Method in class org.hipparchus.stat.correlation.StorelessCovariance
-
Increment the covariance matrix with one row of data.
- increment(double[]) - Method in interface org.hipparchus.stat.descriptive.StorelessMultivariateStatistic
-
Updates the internal state of the statistic to reflect
the addition of the new value.
- increment(double[]) - Method in class org.hipparchus.stat.descriptive.vector.VectorialCovariance
-
Add a new vector to the sample.
- increment(double[]) - Method in class org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
-
Updates the internal state of the statistic to reflect
the addition of the new value.
- increment(int) - Method in class org.hipparchus.util.Incrementor
-
Performs multiple increments.
- INCREMENT - org.hipparchus.ode.sampling.StepNormalizerMode
-
Steps are fixed increments of the start value.
- incrementAll(double[]) - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
-
Updates the internal state of the statistic to reflect addition of
all values in the values array.
- incrementAll(double[], int, int) - Method in interface org.hipparchus.stat.descriptive.StorelessUnivariateStatistic
-
Updates the internal state of the statistic to reflect addition of
the values in the designated portion of the values array.
- incrementEvaluationCount() - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Increment the evaluation count by one.
- incrementEvaluationCount() - Method in class org.hipparchus.optim.BaseOptimizer
-
Increment the evaluation count.
- incrementExact(int) - Static method in class org.hipparchus.util.FastMath
-
Increment a number, detecting overflows.
- incrementExact(long) - Static method in class org.hipparchus.util.FastMath
-
Increment a number, detecting overflows.
- incrementIterationCount() - Method in class org.hipparchus.optim.BaseOptimizer
-
Increment the iteration count.
- incrementIterationCount() - Method in class org.hipparchus.util.IterationManager
-
Increments the iteration count by one, and throws an exception if the
maximum number of iterations is reached.
- Incrementor - Class in org.hipparchus.util
-
Utility that increments a counter until a maximum is reached, at
which point, the instance will by default throw a
MathIllegalStateException
.
- Incrementor() - Constructor for class org.hipparchus.util.Incrementor
-
Creates an Incrementor.
- Incrementor(int) - Constructor for class org.hipparchus.util.Incrementor
-
Creates an Incrementor.
- Incrementor(int, Incrementor.MaxCountExceededCallback) - Constructor for class org.hipparchus.util.Incrementor
-
Creates an Incrementor.
- Incrementor.MaxCountExceededCallback - Interface in org.hipparchus.util
-
Defines a method to be called at counter exhaustion.
- incrementValue(int, long) - Method in class org.hipparchus.stat.LongFrequency
-
Increments the frequency count for v.
- incrementValue(T, long) - Method in class org.hipparchus.stat.Frequency
-
Increments the frequency count for v.
- index - Variable in class org.hipparchus.random.AbstractWell
-
Current index in the bytes pool.
- index(double, int) - Method in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
Finds the index of array that can be used as starting index to
estimate
percentile.
- INDEX - org.hipparchus.exception.LocalizedCoreFormats
-
- INDEX - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INDEX_LARGER_THAN_MAX - org.hipparchus.exception.LocalizedCoreFormats
-
- INDEX_LARGER_THAN_MAX - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INDEX_NOT_POSITIVE - org.hipparchus.exception.LocalizedCoreFormats
-
- INDEX_NOT_POSITIVE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INDEX_OUT_OF_RANGE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INDEX_OUT_OF_RANGE - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- IndexTable(int, int, int, int) - Constructor for class org.hipparchus.random.AbstractWell.IndexTable
-
Creates a new pre-calculated indirection index table.
- INF - Static variable in class org.hipparchus.complex.Complex
-
A complex number representing "+INF + INFi"
- InferenceTestUtils - Class in org.hipparchus.stat.inference
-
A collection of static methods to create inference test instances or to
perform inference tests.
- INFINITE - Static variable in class org.hipparchus.dfp.Dfp
-
Indicator value for Infinity.
- INFINITE_ARRAY_ELEMENT - org.hipparchus.exception.LocalizedCoreFormats
-
- INFINITE_ARRAY_ELEMENT - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INFINITE_BOUND - org.hipparchus.exception.LocalizedCoreFormats
-
- INFINITE_BOUND - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INFINITE_VALUE_CONVERSION - org.hipparchus.exception.LocalizedCoreFormats
-
- INFINITE_VALUE_CONVERSION - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INFINITE_WINDOW - Static variable in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
Represents an infinite window size.
- init(double, double[], double) - Method in interface org.hipparchus.migration.ode.events.EventHandler
-
Deprecated.
Initialize event handler at the start of an ODE integration.
- init(double, double[], double) - Method in interface org.hipparchus.migration.ode.sampling.FixedStepHandler
-
Deprecated.
Initialize step handler at the start of an ODE integration.
- init(double, double[], double) - Method in interface org.hipparchus.migration.ode.sampling.StepHandler
-
Deprecated.
Initialize step handler at the start of an ODE integration.
- init(double, double[], double) - Method in interface org.hipparchus.ode.OrdinaryDifferentialEquation
-
Initialize equations at the start of an ODE integration.
- init(double, double[], double[], double) - Method in interface org.hipparchus.ode.SecondaryODE
-
Initialize equations at the start of an ODE integration.
- init(FieldODEState<T>, T) - Method in class org.hipparchus.ode.FieldExpandableODE
-
Initialize equations at the start of an ODE integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in interface org.hipparchus.ode.events.FieldODEEventHandler
-
Initialize event handler at the start of an ODE integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in class org.hipparchus.ode.FieldDenseOutputModel
-
Initialize step handler at the start of an ODE integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in interface org.hipparchus.ode.sampling.FieldODEFixedStepHandler
-
Initialize step handler at the start of an ODE integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in interface org.hipparchus.ode.sampling.FieldODEStepHandler
-
Initialize step handler at the start of an ODE integration.
- init(FieldODEStateAndDerivative<T>, T) - Method in class org.hipparchus.ode.sampling.FieldStepNormalizer
-
Initialize step handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in interface org.hipparchus.migration.ode.events.EventHandler
-
Deprecated.
Initialize event handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in interface org.hipparchus.migration.ode.sampling.FixedStepHandler
-
Deprecated.
Initialize step handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in interface org.hipparchus.migration.ode.sampling.StepHandler
-
Deprecated.
Initialize step handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in class org.hipparchus.ode.DenseOutputModel
-
Initialize step handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in class org.hipparchus.ode.events.EventFilter
-
Initialize event handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in interface org.hipparchus.ode.events.ODEEventHandler
-
Initialize event handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in interface org.hipparchus.ode.sampling.ODEFixedStepHandler
-
Initialize step handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in interface org.hipparchus.ode.sampling.ODEStepHandler
-
Initialize step handler at the start of an ODE integration.
- init(ODEStateAndDerivative, double) - Method in class org.hipparchus.ode.sampling.StepNormalizer
-
Initialize step handler at the start of an ODE integration.
- init(ODEState, double) - Method in class org.hipparchus.ode.ExpandableODE
-
Initialize equations at the start of an ODE integration.
- init(T, T[], T) - Method in interface org.hipparchus.ode.FieldOrdinaryDifferentialEquation
-
Initialize equations at the start of an ODE integration.
- init(T, T[], T[], T) - Method in interface org.hipparchus.ode.FieldSecondaryODE
-
Initialize equations at the start of an ODE integration.
- INITIAL_CAPACITY_NOT_POSITIVE - org.hipparchus.exception.LocalizedCoreFormats
-
- INITIAL_CAPACITY_NOT_POSITIVE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INITIAL_COLUMN_AFTER_FINAL_COLUMN - org.hipparchus.exception.LocalizedCoreFormats
-
- INITIAL_COLUMN_AFTER_FINAL_COLUMN - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INITIAL_ROW_AFTER_FINAL_ROW - org.hipparchus.exception.LocalizedCoreFormats
-
- INITIAL_ROW_AFTER_FINAL_ROW - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- InitialGuess - Class in org.hipparchus.optim
-
Starting point (first guess) of the optimization procedure.
- InitialGuess(double[]) - Constructor for class org.hipparchus.optim.InitialGuess
-
- initializationPerformed(IterationEvent) - Method in interface org.hipparchus.util.IterationListener
-
Invoked after completion of the initial phase of the iterative algorithm
(prior to the main iteration loop).
- initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.hipparchus.ode.MultistepIntegrator
-
Initialize the high order scaled derivatives at step start.
- initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Initialize the high order scaled derivatives at step start.
- initializeHighOrderDerivatives(double, double[], double[][], double[][]) - Method in class org.hipparchus.ode.nonstiff.AdamsNordsieckTransformer
-
Initialize the high order scaled derivatives at step start.
- initializeHighOrderDerivatives(T, T[], T[][], T[][]) - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Initialize the high order scaled derivatives at step start.
- initializeHighOrderDerivatives(T, T[], T[][], T[][]) - Method in class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Initialize the high order scaled derivatives at step start.
- initializeHighOrderDerivatives(T, T[], T[][], T[][]) - Method in class org.hipparchus.ode.nonstiff.AdamsNordsieckFieldTransformer
-
Initialize the high order scaled derivatives at step start.
- initializeStep(boolean, int, double[], ODEStateAndDerivative, EquationsMapper) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Initialize the integration step.
- initializeStep(boolean, int, T[], FieldODEStateAndDerivative<T>, FieldEquationsMapper<T>) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Initialize the integration step.
- initIntegration(ExpandableODE, ODEState, double) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Prepare the start of an integration.
- initIntegration(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Prepare the start of an integration.
- INPUT_ARRAY - org.hipparchus.exception.LocalizedCoreFormats
-
- INPUT_ARRAY - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- insertCut(Hyperplane<S>) - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Insert a cut sub-hyperplane in a node.
- insertEquationData(int, double[], double[]) - Method in class org.hipparchus.ode.EquationsMapper
-
Insert equation data into a complete state or derivative array.
- insertEquationData(int, T[], T[]) - Method in class org.hipparchus.ode.FieldEquationsMapper
-
Insert equation data into a complete state or derivative array.
- insertInTree(BSPTree<S>, boolean, BSPTree.VanishingCutHandler<S>) - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Insert the instance into another tree.
- INSIDE - org.hipparchus.geometry.partitioning.Region.Location
-
Code for points inside the partition.
- INSUFFICIENT_DATA - org.hipparchus.exception.LocalizedCoreFormats
-
- INSUFFICIENT_DATA - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INSUFFICIENT_DATA_FOR_T_STATISTIC - org.hipparchus.exception.LocalizedCoreFormats
-
Deprecated.
- INSUFFICIENT_DATA_FOR_T_STATISTIC - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INSUFFICIENT_DATA_FOR_T_STATISTIC - org.hipparchus.stat.LocalizedStatFormats
-
- INSUFFICIENT_DIMENSION - org.hipparchus.exception.LocalizedCoreFormats
-
- INSUFFICIENT_DIMENSION - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INSUFFICIENT_OBSERVED_POINTS_IN_SAMPLE - org.hipparchus.exception.LocalizedCoreFormats
-
- INSUFFICIENT_OBSERVED_POINTS_IN_SAMPLE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INSUFFICIENT_ROWS_AND_COLUMNS - org.hipparchus.exception.LocalizedCoreFormats
-
- INSUFFICIENT_ROWS_AND_COLUMNS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- InsufficientDataException - Exception in org.hipparchus.migration.exception
-
- InsufficientDataException() - Constructor for exception org.hipparchus.migration.exception.InsufficientDataException
-
Deprecated.
Construct the exception.
- InsufficientDataException(Localizable, Object...) - Constructor for exception org.hipparchus.migration.exception.InsufficientDataException
-
Deprecated.
Construct the exception with a specific context.
- INTEGER_ZERO - Static variable in exception org.hipparchus.migration.exception.MathIllegalNumberException
-
Deprecated.
Helper to avoid boxing warnings.
- IntegerDistribution - Interface in org.hipparchus.distribution
-
Interface for discrete distributions.
- IntegerDistributionComparison - Class in org.hipparchus.samples
-
Displays pdf/cdf for integer distributions.
- IntegerDistributionComparison() - Constructor for class org.hipparchus.samples.IntegerDistributionComparison
-
- IntegerDistributionComparison.Display - Class in org.hipparchus.samples
-
- integrate(double, double) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Returns the definite integral of this polymomial over the given interval.
- integrate(int, UnivariateFunction, double, double) - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Integrate the function in the given interval.
- integrate(int, UnivariateFunction, double, double) - Method in interface org.hipparchus.analysis.integration.UnivariateIntegrator
-
Integrate the function in the given interval.
- integrate(UnivariateFunction) - Method in class org.hipparchus.analysis.integration.gauss.GaussIntegrator
-
Returns an estimate of the integral of f(x) * w(x)
,
where w
is a weight function that depends on the actual
flavor of the Gauss integration scheme.
- integrate(UnivariateFunction) - Method in class org.hipparchus.analysis.integration.gauss.SymmetricGaussIntegrator
-
Returns an estimate of the integral of f(x) * w(x)
,
where w
is a weight function that depends on the actual
flavor of the Gauss integration scheme.
- integrate(ExpandableODE, ODEState, double) - Method in class org.hipparchus.ode.nonstiff.AdamsBashforthIntegrator
-
Integrate the differential equations up to the given time.
- integrate(ExpandableODE, ODEState, double) - Method in class org.hipparchus.ode.nonstiff.AdamsIntegrator
-
Integrate the differential equations up to the given time.
- integrate(ExpandableODE, ODEState, double) - Method in class org.hipparchus.ode.nonstiff.AdamsMoultonIntegrator
-
Integrate the differential equations up to the given time.
- integrate(ExpandableODE, ODEState, double) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Integrate the differential equations up to the given time.
- integrate(ExpandableODE, ODEState, double) - Method in class org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
-
Integrate the differential equations up to the given time.
- integrate(ExpandableODE, ODEState, double) - Method in class org.hipparchus.ode.nonstiff.RungeKuttaIntegrator
-
Integrate the differential equations up to the given time.
- integrate(ExpandableODE, ODEState, double) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Integrate the differential equations up to the given time.
- integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Integrate the differential equations up to the given time.
- integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.hipparchus.ode.nonstiff.AdamsBashforthFieldIntegrator
-
Integrate the differential equations up to the given time.
- integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.hipparchus.ode.nonstiff.AdamsFieldIntegrator
-
Integrate the differential equations up to the given time.
- integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.hipparchus.ode.nonstiff.AdamsMoultonFieldIntegrator
-
Integrate the differential equations up to the given time.
- integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Integrate the differential equations up to the given time.
- integrate(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Integrate the differential equations up to the given time.
- integrate(OrdinaryDifferentialEquation, double, double[], double, double[]) - Method in interface org.hipparchus.ode.ODEIntegrator
-
- integrate(OrdinaryDifferentialEquation, ODEState, double) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Integrate the differential equations up to the given time.
- INTEGRATION_METHOD_NEEDS_AT_LEAST_TWO_PREVIOUS_POINTS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INTEGRATION_METHOD_NEEDS_AT_LEAST_TWO_PREVIOUS_POINTS - org.hipparchus.ode.LocalizedODEFormats
-
- INTERNAL_ERROR - org.hipparchus.exception.LocalizedCoreFormats
-
- INTERNAL_ERROR - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- interpolate(double[][], double[]) - Method in class org.hipparchus.analysis.interpolation.MicrosphereProjectionInterpolator
-
Computes an interpolating function for the data set.
- interpolate(double[][], double[]) - Method in interface org.hipparchus.analysis.interpolation.MultivariateInterpolator
-
Computes an interpolating function for the data set.
- interpolate(double[], double[]) - Method in class org.hipparchus.analysis.interpolation.AkimaSplineInterpolator
-
Computes an interpolating function for the data set.
- interpolate(double[], double[]) - Method in class org.hipparchus.analysis.interpolation.DividedDifferenceInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[]) - Method in class org.hipparchus.analysis.interpolation.LinearInterpolator
-
Computes a linear interpolating function for the data set.
- interpolate(double[], double[]) - Method in class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Compute an interpolating function by performing a loess fit
on the data at the original abscissae and then building a cubic spline
with a
SplineInterpolator
on the resulting fit.
- interpolate(double[], double[]) - Method in class org.hipparchus.analysis.interpolation.NevilleInterpolator
-
Computes an interpolating function for the data set.
- interpolate(double[], double[]) - Method in class org.hipparchus.analysis.interpolation.SplineInterpolator
-
Computes an interpolating function for the data set.
- interpolate(double[], double[]) - Method in interface org.hipparchus.analysis.interpolation.UnivariateInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[]) - Method in class org.hipparchus.analysis.interpolation.UnivariatePeriodicInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[], double[][]) - Method in class org.hipparchus.analysis.interpolation.BicubicInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[], double[][]) - Method in interface org.hipparchus.analysis.interpolation.BivariateGridInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[], double[][]) - Method in class org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[], double[], double[][][]) - Method in class org.hipparchus.analysis.interpolation.TricubicInterpolator
-
Compute an interpolating function for the dataset.
- interpolate(double[], double[], double[], double[][][]) - Method in interface org.hipparchus.analysis.interpolation.TrivariateGridInterpolator
-
Compute an interpolating function for the dataset.
- InterpolatingMicrosphere - Class in org.hipparchus.analysis.interpolation
-
- InterpolatingMicrosphere(int, int, double, double, double) - Constructor for class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Create an unitialiazed sphere.
- InterpolatingMicrosphere(int, int, double, double, double, UnitSphereRandomVectorGenerator) - Constructor for class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Create a sphere from randomly sampled vectors.
- InterpolatingMicrosphere(InterpolatingMicrosphere) - Constructor for class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Copy constructor.
- InterpolatingMicrosphere2D - Class in org.hipparchus.analysis.interpolation
-
- InterpolatingMicrosphere2D(int, double, double, double) - Constructor for class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere2D
-
Create a sphere from vectors regularly sampled around a circle.
- InterpolatingMicrosphere2D(InterpolatingMicrosphere2D) - Constructor for class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere2D
-
Copy constructor.
- intersection(FieldLine<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Get the intersection point of the instance and another line.
- intersection(Line) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Get the intersection point of the instance and another line.
- intersection(Line) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the intersection of a line with the instance.
- intersection(Plane) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Build the line shared by the instance and another plane.
- intersection(Plane, Plane, Plane) - Static method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Get the intersection point of three planes.
- intersection(SubLine, boolean) - Method in class org.hipparchus.geometry.euclidean.threed.SubLine
-
Get the intersection of the instance and another sub-line.
- intersection(Line) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Get the intersection point of the instance and another line.
- intersection(SubLine, boolean) - Method in class org.hipparchus.geometry.euclidean.twod.SubLine
-
Get the intersection of the instance and another sub-line.
- intersection(Region<S>, Region<S>) - Method in class org.hipparchus.geometry.partitioning.RegionFactory
-
Compute the intersection of two regions.
- intersection(SubHyperplane<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Get the parts of a sub-hyperplane that are contained in the region.
- intersection(SubHyperplane<S>) - Method in interface org.hipparchus.geometry.partitioning.Region
-
Get the parts of a sub-hyperplane that are contained in the region.
- Interval - Class in org.hipparchus.geometry.euclidean.oned
-
This class represents a 1D interval.
- Interval(double, double) - Constructor for class org.hipparchus.geometry.euclidean.oned.Interval
-
Simple constructor.
- Interval(double, double, double, double) - Constructor for class org.hipparchus.analysis.solvers.BracketedUnivariateSolver.Interval
-
Construct a new interval with the given end points.
- Interval(T, T, T, T) - Constructor for class org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver.Interval
-
Construct a new interval with the given end points.
- IntervalsSet - Class in org.hipparchus.geometry.euclidean.oned
-
This class represents a 1D region: a set of intervals.
- IntervalsSet(double) - Constructor for class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Build an intervals set representing the whole real line.
- IntervalsSet(double, double, double) - Constructor for class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Build an intervals set corresponding to a single interval.
- IntervalsSet(Collection<SubHyperplane<Euclidean1D>>, double) - Constructor for class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Build an intervals set from a Boundary REPresentation (B-rep).
- IntervalsSet(BSPTree<Euclidean1D>, double) - Constructor for class org.hipparchus.geometry.euclidean.oned.IntervalsSet
-
Build an intervals set from an inside/outside BSP tree.
- intLog10() - Method in class org.hipparchus.dfp.Dfp
-
Get the exponent of the greatest power of 10 that is less than or equal to abs(this).
- intValue() - Method in class org.hipparchus.dfp.Dfp
-
Convert this to an integer.
- intValue() - Method in class org.hipparchus.fraction.BigFraction
-
Gets the fraction as an int
.
- intValue() - Method in class org.hipparchus.fraction.Fraction
-
Gets the fraction as an int
.
- intValue() - Method in class org.hipparchus.util.Decimal64
-
The current implementation performs casting to a int
.
- INVALID_BRACKETING_PARAMETERS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INVALID_BRACKETING_PARAMETERS - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- INVALID_IMPLEMENTATION - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INVALID_IMPLEMENTATION - org.hipparchus.optim.LocalizedOptimFormats
-
- INVALID_INTERVAL_INITIAL_VALUE_PARAMETERS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INVALID_INTERVAL_INITIAL_VALUE_PARAMETERS - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- INVALID_ITERATIONS_LIMITS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INVALID_ITERATIONS_LIMITS - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- INVALID_MAX_ITERATIONS - org.hipparchus.exception.LocalizedCoreFormats
-
- INVALID_MAX_ITERATIONS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INVALID_REGRESSION_ARRAY - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INVALID_REGRESSION_ARRAY - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- INVALID_REGRESSION_OBSERVATION - org.hipparchus.exception.LocalizedCoreFormats
-
Deprecated.
- INVALID_REGRESSION_OBSERVATION - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- INVALID_REGRESSION_OBSERVATION - org.hipparchus.stat.LocalizedStatFormats
-
- INVALID_ROUNDING_METHOD - org.hipparchus.exception.LocalizedCoreFormats
-
- INVALID_ROUNDING_METHOD - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- InvalidRepresentationException - Exception in org.hipparchus.migration.genetics
-
- InvalidRepresentationException(Localizable, Object...) - Constructor for exception org.hipparchus.migration.genetics.InvalidRepresentationException
-
Deprecated.
Construct an InvalidRepresentationException with a specialized message.
- inverse() - Method in class org.hipparchus.linear.DiagonalMatrix
-
Computes the inverse of this diagonal matrix.
- inverse(double) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Computes the inverse of this diagonal matrix.
- inverse(RealMatrix) - Static method in class org.hipparchus.linear.MatrixUtils
-
Computes the inverse of the given matrix.
- inverse(RealMatrix, double) - Static method in class org.hipparchus.linear.MatrixUtils
-
Computes the inverse of the given matrix.
- Inverse - Class in org.hipparchus.analysis.function
-
Inverse function.
- Inverse() - Constructor for class org.hipparchus.analysis.function.Inverse
-
- INVERSE - org.hipparchus.transform.TransformType
-
The type to be specified for inverse transforms.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.AbstractRealDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.UniformRealDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.discrete.AbstractIntegerDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in interface org.hipparchus.distribution.IntegerDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in interface org.hipparchus.distribution.RealDistribution
-
Computes the quantile function of this distribution.
- inverseCumulativeProbability(double) - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Computes the quantile function of this distribution.
- invGamma1pm1(double) - Static method in class org.hipparchus.special.Gamma
-
Returns the value of 1 / Γ(1 + x) - 1 for -0.5 ≤ x ≤
1.5.
- ISAACRandom - Class in org.hipparchus.random
-
A fast cryptographic pseudo-random number generator.
- ISAACRandom() - Constructor for class org.hipparchus.random.ISAACRandom
-
Creates a new ISAAC random number generator.
- ISAACRandom(int[]) - Constructor for class org.hipparchus.random.ISAACRandom
-
Creates a new ISAAC random number generator using an int array seed.
- ISAACRandom(long) - Constructor for class org.hipparchus.random.ISAACRandom
-
Creates a new ISAAC random number generator using a single long seed.
- isBetterScore(double, double) - Method in class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
Returns whether the first evaluation score is considered to be better
than the second one by this evaluator.
- isBiasCorrected() - Method in class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Returns true iff biasCorrected property is set to true.
- isBiasCorrected() - Method in class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
- isBiasCorrected() - Method in class org.hipparchus.stat.descriptive.moment.Variance
-
- isBracketing(double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Check whether the function takes opposite signs at the endpoints.
- isBracketing(UnivariateFunction, double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Check whether the interval bounds bracket a root.
- isCounterClockWise() - Method in class org.hipparchus.complex.RootsOfUnity
-
- isCurrentStateInterpolated() - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
- isCurrentStateInterpolated() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
- isCurrentStateInterpolated() - Method in interface org.hipparchus.ode.sampling.FieldODEStateInterpolator
-
- isCurrentStateInterpolated() - Method in interface org.hipparchus.ode.sampling.ODEStateInterpolator
-
- isDefaultValue(double) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Determine if this value is within epsilon of zero.
- isDirect() - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Check if the hyperplane orientation is direct.
- isDirect() - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Check if the hyperplane orientation is direct.
- isEmpty() - Method in class org.hipparchus.geometry.euclidean.oned.SubOrientedPoint
-
Check if the instance is empty.
- isEmpty() - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check if the instance is empty.
- isEmpty() - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Check if the instance is empty.
- isEmpty() - Method in interface org.hipparchus.geometry.partitioning.Region
-
Check if the instance is empty.
- isEmpty() - Method in interface org.hipparchus.geometry.partitioning.SubHyperplane
-
Check if the instance is empty.
- isEmpty() - Method in class org.hipparchus.geometry.spherical.oned.SubLimitAngle
-
Check if the instance is empty.
- isEmpty(BSPTree<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check if the sub-tree starting at a given node is empty.
- isEmpty(BSPTree<S>) - Method in interface org.hipparchus.geometry.partitioning.Region
-
Check if the sub-tree starting at a given node is empty.
- isFormNormalEquations() - Method in enum org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer.Decomposition
-
Deprecated.
Get if this decomposition forms the normal equations explicitly.
- isFormNormalEquations() - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer
-
Get if the normal equations are explicitly formed.
- isForward() - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
Deprecated.
Check if the natural integration direction is forward.
- isForward() - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
Check if the natural integration direction is forward.
- isForward() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
Check if the natural integration direction is forward.
- isForward() - Method in interface org.hipparchus.ode.sampling.FieldODEStateInterpolator
-
Check if the natural integration direction is forward.
- isForward() - Method in interface org.hipparchus.ode.sampling.ODEStateInterpolator
-
Check if the natural integration direction is forward.
- isFull() - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check if the instance covers the full space.
- isFull() - Method in interface org.hipparchus.geometry.partitioning.Region
-
Check if the instance covers the full space.
- isFull(BSPTree<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Check if the sub-tree starting at a given node covers the full space.
- isFull(BSPTree<S>) - Method in interface org.hipparchus.geometry.partitioning.Region
-
Check if the sub-tree starting at a given node covers the full space.
- isInfinite() - Method in class org.hipparchus.complex.Complex
-
Checks whether either the real or imaginary part of this complex number
takes an infinite value (either Double.POSITIVE_INFINITY
or
Double.NEGATIVE_INFINITY
) and neither part
is NaN
.
- isInfinite() - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is infinite.
- isInfinite() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Returns true if any coordinate of this vector is infinite and none are NaN;
false otherwise
- isInfinite() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Returns true if any coordinate of this vector is infinite and none are NaN;
false otherwise
- isInfinite() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Returns true if any coordinate of this vector is infinite and none are NaN;
false otherwise
- isInfinite() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Returns true if any coordinate of this vector is infinite and none are NaN;
false otherwise
- isInfinite() - Method in interface org.hipparchus.geometry.Vector
-
Returns true if any coordinate of this vector is infinite and none are NaN;
false otherwise
- isInfinite() - Method in class org.hipparchus.linear.ArrayRealVector
-
Check whether any coordinate of this vector is infinite and none
are NaN
.
- isInfinite() - Method in class org.hipparchus.linear.OpenMapRealVector
-
Check whether any coordinate of this vector is infinite and none are NaN
.
- isInfinite() - Method in class org.hipparchus.linear.RealVector
-
Check whether any coordinate of this vector is infinite and none are NaN
.
- isInfinite() - Method in class org.hipparchus.util.Decimal64
-
- isLastStep() - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Check if this step is the last one.
- isLastStep() - Method in class org.hipparchus.ode.AbstractIntegrator
-
Check if this step is the last one.
- isLoaded() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Property indicating whether or not the distribution has been loaded.
- isMonotonic(double[], MathArrays.OrderDirection, boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that an array is monotonically increasing or decreasing.
- isMonotonic(T[], MathArrays.OrderDirection, boolean) - Static method in class org.hipparchus.util.MathArrays
-
Check that an array is monotonically increasing or decreasing.
- isNaN() - Method in class org.hipparchus.complex.Complex
-
Checks whether either or both parts of this complex number is
NaN
.
- isNaN() - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is not a number.
- isNaN() - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Returns true if any coordinate of this point is NaN; false otherwise
- isNaN() - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Returns true if any coordinate of this vector is NaN; false otherwise
- isNaN() - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Returns true if any coordinate of this point is NaN; false otherwise
- isNaN() - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Returns true if any coordinate of this point is NaN; false otherwise
- isNaN() - Method in interface org.hipparchus.geometry.Point
-
Returns true if any coordinate of this point is NaN; false otherwise
- isNaN() - Method in class org.hipparchus.geometry.spherical.oned.S1Point
-
Returns true if any coordinate of this point is NaN; false otherwise
- isNaN() - Method in class org.hipparchus.geometry.spherical.twod.S2Point
-
Returns true if any coordinate of this point is NaN; false otherwise
- isNaN() - Method in class org.hipparchus.linear.ArrayRealVector
-
Check if any coordinate of this vector is NaN
.
- isNaN() - Method in class org.hipparchus.linear.OpenMapRealVector
-
Check whether any coordinate of this vector is NaN
.
- isNaN() - Method in class org.hipparchus.linear.RealVector
-
Check whether any coordinate of this vector is NaN
.
- isNaN() - Method in class org.hipparchus.util.Decimal64
-
Returns true
if this
double precision number is
Not-a-Number (NaN
), false otherwise.
- isNoIntercept() - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
- isNonSingular() - Method in interface org.hipparchus.linear.DecompositionSolver
-
Check if the decomposed matrix is non-singular.
- isNonSingular() - Method in interface org.hipparchus.linear.FieldDecompositionSolver
-
Check if the decomposed matrix is non-singular.
- isParallelTo(Line) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Check the instance is parallel to another line.
- isPowerOfTwo(long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Returns true if the argument is a power of two.
- isPreviousStateInterpolated() - Method in class org.hipparchus.ode.sampling.AbstractFieldODEStateInterpolator
-
- isPreviousStateInterpolated() - Method in class org.hipparchus.ode.sampling.AbstractODEStateInterpolator
-
- isPreviousStateInterpolated() - Method in interface org.hipparchus.ode.sampling.FieldODEStateInterpolator
-
- isPreviousStateInterpolated() - Method in interface org.hipparchus.ode.sampling.ODEStateInterpolator
-
- isPureQuaternion(double) - Method in class org.hipparchus.complex.Quaternion
-
Checks whether the instance is a pure quaternion within a given
tolerance.
- isRestrictedToNonNegative() - Method in class org.hipparchus.optim.linear.LinearOptimizer
-
- isRestrictedToNonNegative() - Method in class org.hipparchus.optim.linear.NonNegativeConstraint
-
Indicates whether all the variables must be restricted to non-negative
values.
- isSequence(double, double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Check whether the arguments form a (strictly) increasing sequence.
- isSequence(double, double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Check whether the arguments form a (strictly) increasing sequence.
- isSimilarTo(FieldLine<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldLine
-
Check if the instance is similar to another line.
- isSimilarTo(Line) - Method in class org.hipparchus.geometry.euclidean.threed.Line
-
Check if the instance is similar to another line.
- isSimilarTo(Plane) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Check if the instance is similar to another plane.
- isSingular(double) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns whether this diagonal matrix is singular, i.e.
- isSolutionOptimal() - Method in class org.hipparchus.optim.linear.SolutionCallback
-
Returns if the found solution is optimal.
- isSquare() - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Is this a square matrix?
- isSquare() - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Is this a square matrix?
- isSquare() - Method in interface org.hipparchus.linear.AnyMatrix
-
Is this a square matrix?
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.BetaDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.CauchyDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.ChiSquaredDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.ConstantRealDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.EnumeratedRealDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.ExponentialDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.FDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.GammaDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.GumbelDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.LaplaceDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.LevyDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.LogisticDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.LogNormalDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.NakagamiDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.NormalDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.ParetoDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.TDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.TriangularDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.UniformRealDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.continuous.WeibullDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.discrete.BinomialDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.discrete.EnumeratedIntegerDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.discrete.GeometricDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.discrete.HypergeometricDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.discrete.PascalDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.discrete.PoissonDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.discrete.UniformIntegerDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in class org.hipparchus.distribution.discrete.ZipfDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in interface org.hipparchus.distribution.IntegerDistribution
-
Use this method to get information about whether the support is
connected, i.e.
- isSupportConnected() - Method in interface org.hipparchus.distribution.RealDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupportConnected() - Method in class org.hipparchus.stat.fitting.EmpiricalDistribution
-
Use this method to get information about whether the support is connected,
i.e.
- isSupported(String) - Method in class org.hipparchus.ode.AbstractParameterizable
-
Check if a parameter is supported.
- isSupported(String) - Method in interface org.hipparchus.ode.ODEJacobiansProvider
-
Check if a parameter is supported.
- isSupported(String) - Method in interface org.hipparchus.ode.Parameterizable
-
Check if a parameter is supported.
- isSymmetric(RealMatrix, double) - Static method in class org.hipparchus.linear.MatrixUtils
-
Checks whether a matrix is symmetric.
- isTransposable() - Method in interface org.hipparchus.linear.RealLinearOperator
-
- isUnitQuaternion(double) - Method in class org.hipparchus.complex.Quaternion
-
Checks whether the instance is a unit quaternion within a given
tolerance.
- isValidPoint(double) - Method in class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Indicates whether a point is within the interpolation range.
- isValidPoint(double, double) - Method in class org.hipparchus.analysis.interpolation.BicubicInterpolatingFunction
-
Indicates whether a point is within the interpolation range.
- isValidPoint(double, double) - Method in class org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolatingFunction
-
Indicates whether a point is within the interpolation range.
- isValidPoint(double, double, double) - Method in class org.hipparchus.analysis.interpolation.TricubicInterpolatingFunction
-
Indicates whether a point is within the interpolation range.
- isZero() - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is equal to zero.
- iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Compute the next simplex of the algorithm.
- iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.MultiDirectionalSimplex
-
Compute the next simplex of the algorithm.
- iterate(MultivariateFunction, Comparator<PointValuePair>) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.NelderMeadSimplex
-
Compute the next simplex of the algorithm.
- IterationEvent - Class in org.hipparchus.util
-
The root class from which all events occurring while running an
IterationManager
should be derived.
- IterationEvent(Object, int) - Constructor for class org.hipparchus.util.IterationEvent
-
Creates a new instance of this class.
- IterationListener - Interface in org.hipparchus.util
-
The listener interface for receiving events occurring in an iterative
algorithm.
- IterationManager - Class in org.hipparchus.util
-
This abstract class provides a general framework for managing iterative
algorithms.
- IterationManager(int) - Constructor for class org.hipparchus.util.IterationManager
-
Creates a new instance of this class.
- IterationManager(int, Incrementor.MaxCountExceededCallback) - Constructor for class org.hipparchus.util.IterationManager
-
Creates a new instance of this class.
- iterationPerformed(IterationEvent) - Method in interface org.hipparchus.util.IterationListener
-
Invoked each time an iteration is completed (in the main iteration loop).
- iterations - Variable in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
The iteration count.
- iterations - Variable in class org.hipparchus.optim.BaseOptimizer
-
Iterations counter.
- ITERATIONS - org.hipparchus.exception.LocalizedCoreFormats
-
- ITERATIONS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- iterationStarted(IterationEvent) - Method in interface org.hipparchus.util.IterationListener
-
Invoked each time a new iteration is completed (in the main iteration
loop).
- IterativeLegendreGaussIntegrator - Class in org.hipparchus.analysis.integration
-
This algorithm divides the integration interval into equally-sized
sub-interval and on each of them performs a
Legendre-Gauss quadrature.
- IterativeLegendreGaussIntegrator(int, double, double) - Constructor for class org.hipparchus.analysis.integration.IterativeLegendreGaussIntegrator
-
Builds an integrator with given accuracies.
- IterativeLegendreGaussIntegrator(int, double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.IterativeLegendreGaussIntegrator
-
Builds an integrator with given accuracies and iterations counts.
- IterativeLegendreGaussIntegrator(int, int, int) - Constructor for class org.hipparchus.analysis.integration.IterativeLegendreGaussIntegrator
-
Builds an integrator with given iteration counts.
- IterativeLinearSolver - Class in org.hipparchus.linear
-
This abstract class defines an iterative solver for the linear system A
· x = b.
- IterativeLinearSolver(int) - Constructor for class org.hipparchus.linear.IterativeLinearSolver
-
Creates a new instance of this class, with default iteration manager.
- IterativeLinearSolver(IterationManager) - Constructor for class org.hipparchus.linear.IterativeLinearSolver
-
Creates a new instance of this class, with custom iteration manager.
- IterativeLinearSolverEvent - Class in org.hipparchus.linear
-
- IterativeLinearSolverEvent(Object, int) - Constructor for class org.hipparchus.linear.IterativeLinearSolverEvent
-
Creates a new instance of this class.
- iterator() - Method in class org.hipparchus.geometry.euclidean.oned.IntervalsSet
- iterator() - Method in class org.hipparchus.geometry.partitioning.NodesSet
- iterator() - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet
- iterator() - Method in class org.hipparchus.linear.RealVector
-
Generic dense iterator.
- iterator() - Method in class org.hipparchus.util.Combinations
- iterator() - Method in class org.hipparchus.util.MultidimensionalCounter
-
Create an iterator over this counter.
- iterator() - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
-
Get an iterator over map elements.
- iterator() - Method in class org.hipparchus.util.OpenIntToFieldHashMap
-
Get an iterator over map elements.
- ITERATOR_EXHAUSTED - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- ITERATOR_EXHAUSTED - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- S1Point - Class in org.hipparchus.geometry.spherical.oned
-
This class represents a point on the 1-sphere.
- S1Point(double) - Constructor for class org.hipparchus.geometry.spherical.oned.S1Point
-
Simple constructor.
- S2Point - Class in org.hipparchus.geometry.spherical.twod
-
This class represents a point on the 2-sphere.
- S2Point(double, double) - Constructor for class org.hipparchus.geometry.spherical.twod.S2Point
-
Simple constructor.
- S2Point(Vector3D) - Constructor for class org.hipparchus.geometry.spherical.twod.S2Point
-
Simple constructor.
- SAFE_MIN - Static variable in class org.hipparchus.util.Precision
-
Safe minimum, such that 1 / SAFE_MIN
does not overflow.
- safeNorm(double[]) - Static method in class org.hipparchus.util.MathArrays
-
Returns the Cartesian norm (2-norm), handling both overflow and underflow.
- SAME_SIGN_AT_ENDPOINTS - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- SAME_SIGN_AT_ENDPOINTS - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- sameOrientationAs(Hyperplane<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.OrientedPoint
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Plane
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.oned.LimitAngle
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<Sphere2D>) - Method in class org.hipparchus.geometry.spherical.twod.Circle
-
Check if the instance has the same orientation as another hyperplane.
- sameOrientationAs(Hyperplane<S>) - Method in interface org.hipparchus.geometry.partitioning.Hyperplane
-
Check if the instance has the same orientation as another hyperplane.
- sample() - Method in class org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
-
Generates a random value vector sampled from this distribution.
- sample() - Method in class org.hipparchus.distribution.multivariate.MixtureMultivariateRealDistribution
-
Generates a random value vector sampled from this distribution.
- sample() - Method in class org.hipparchus.distribution.multivariate.MultivariateNormalDistribution
-
Generates a random value vector sampled from this distribution.
- sample() - Method in interface org.hipparchus.distribution.MultivariateRealDistribution
-
Generates a random value vector sampled from this distribution.
- sample(int) - Method in class org.hipparchus.distribution.multivariate.AbstractMultivariateRealDistribution
-
Generates a list of a random value vectors from the distribution.
- sample(int) - Method in interface org.hipparchus.distribution.MultivariateRealDistribution
-
Generates a list of a random value vectors from the distribution.
- sample(UnivariateFunction, double, double, int) - Static method in class org.hipparchus.analysis.FunctionUtils
-
Samples the specified univariate real function on the specified interval.
- SAMPLE_SIZE_EXCEEDS_COLLECTION_SIZE - org.hipparchus.exception.LocalizedCoreFormats
-
- SAMPLE_SIZE_EXCEEDS_COLLECTION_SIZE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- SAMPLE_SIZE_LARGER_THAN_POPULATION_SIZE - org.hipparchus.exception.LocalizedCoreFormats
-
- SAMPLE_SIZE_LARGER_THAN_POPULATION_SIZE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- sanityChecks(FieldODEState<T>, T) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Check the integration span.
- sanityChecks(FieldODEState<T>, T) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Check the integration span.
- sanityChecks(ODEState, double) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Check the integration span.
- sanityChecks(ODEState, double) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Check the integration span.
- scalAbsoluteTolerance - Variable in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Allowed absolute scalar error.
- scalAbsoluteTolerance - Variable in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed absolute scalar error.
- scalarAdd(double) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of adding d
to each entry of this
.
- scalarAdd(double) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of adding d
to each entry of this
.
- scalarAdd(double) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of adding d
to each entry of this
.
- scalarAdd(T) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Increment each entry of this matrix.
- scalarAdd(T) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Increment each entry of this matrix.
- scalarAdd(T) - Method in interface org.hipparchus.linear.FieldMatrix
-
Increment each entry of this matrix.
- scalarMultiply(double) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in interface org.hipparchus.geometry.Vector
-
Multiply the instance by a scalar.
- scalarMultiply(double) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns the result of multiplying each entry of this
by
d
.
- scalarMultiply(double) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns the result of multiplying each entry of this
by
d
.
- scalarMultiply(double) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns the result of multiplying each entry of this
by
d
.
- scalarMultiply(T) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Multiply the instance by a scalar.
- scalarMultiply(T) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Multiply each entry by d
.
- scalarMultiply(T) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Multiply each entry by d
.
- scalarMultiply(T) - Method in interface org.hipparchus.linear.FieldMatrix
-
Multiply each entry by d
.
- scalb(double, int) - Static method in class org.hipparchus.util.FastMath
-
Multiply a double number by a power of 2.
- scalb(float, int) - Static method in class org.hipparchus.util.FastMath
-
Multiply a float number by a power of 2.
- scalb(int) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.dfp.Dfp
-
Multiply the instance by a power of 2.
- scalb(int) - Method in interface org.hipparchus.RealFieldElement
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.util.Decimal64
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.util.FieldTuple
-
Multiply the instance by a power of 2.
- scalb(int) - Method in class org.hipparchus.util.Tuple
-
Multiply the instance by a power of 2.
- scalb(T, int) - Static method in class org.hipparchus.util.FastMath
-
Multiply a double number by a power of 2.
- scale(double, double[]) - Static method in class org.hipparchus.util.MathArrays
-
Create a copy of an array scaled by a value.
- SCALE - org.hipparchus.exception.LocalizedCoreFormats
-
- SCALE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- scaleArray(double[], double) - Static method in class org.hipparchus.transform.TransformUtils
-
Multiply every component in the given real array by the
given real number.
- scaleArray(Complex[], double) - Static method in class org.hipparchus.transform.TransformUtils
-
Multiply every component in the given complex array by the
given real number.
- scaled - Variable in class org.hipparchus.ode.MultistepFieldIntegrator
-
First scaled derivative (h y').
- scaled - Variable in class org.hipparchus.ode.MultistepIntegrator
-
First scaled derivative (h y').
- scaleInPlace(double, double[]) - Static method in class org.hipparchus.util.MathArrays
-
Multiply each element of an array by a value.
- scalRelativeTolerance - Variable in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Allowed relative scalar error.
- scalRelativeTolerance - Variable in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed relative scalar error.
- score(List<? extends Cluster<T>>) - Method in class org.hipparchus.clustering.evaluation.ClusterEvaluator
-
Computes the evaluation score for the given list of clusters.
- score(List<? extends Cluster<T>>) - Method in class org.hipparchus.clustering.evaluation.SumOfClusterVariances
-
Computes the evaluation score for the given list of clusters.
- scramble(int, int, int, int) - Method in class org.hipparchus.random.HaltonSequenceGenerator
-
Performs scrambling of digit d_j
according to the formula:
- search(double[], double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.LineSearch
-
Finds the number alpha
that optimizes
f(startPoint + alpha * direction)
.
- search(UnivariateFunction, GoalType, double, double) - Method in class org.hipparchus.optim.univariate.BracketFinder
-
Search new points that bracket a local optimum of the function.
- SearchInterval - Class in org.hipparchus.optim.univariate
-
Search interval and (optional) start value.
- SearchInterval(double, double) - Constructor for class org.hipparchus.optim.univariate.SearchInterval
-
- SearchInterval(double, double, double) - Constructor for class org.hipparchus.optim.univariate.SearchInterval
-
- SecantSolver - Class in org.hipparchus.analysis.solvers
-
Implements the Secant method for root-finding (approximating a
zero of a univariate real function).
- SecantSolver() - Constructor for class org.hipparchus.analysis.solvers.SecantSolver
-
Construct a solver with default accuracy (1e-6).
- SecantSolver(double) - Constructor for class org.hipparchus.analysis.solvers.SecantSolver
-
Construct a solver.
- SecantSolver(double, double) - Constructor for class org.hipparchus.analysis.solvers.SecantSolver
-
Construct a solver.
- SecondaryEquations - Interface in org.hipparchus.migration.ode
-
- SecondaryODE - Interface in org.hipparchus.ode
-
This interface allows users to add secondary differential equations to a primary
set of differential equations.
- SecondMoment - Class in org.hipparchus.stat.descriptive.moment
-
Computes a statistic related to the Second Central Moment.
- SecondMoment() - Constructor for class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Create a SecondMoment instance.
- SecondMoment(SecondMoment) - Constructor for class org.hipparchus.stat.descriptive.moment.SecondMoment
-
Copy constructor, creates a new SecondMoment
identical
to the original
.
- SecondOrderDifferentialEquations - Interface in org.hipparchus.migration.ode
-
- SecondOrderODE - Interface in org.hipparchus.ode
-
This interface represents a second order differential equations set.
- Segment - Class in org.hipparchus.geometry.euclidean.threed
-
Simple container for a two-points segment.
- Segment - Class in org.hipparchus.geometry.euclidean.twod
-
Simple container for a two-points segment.
- Segment(Vector3D, Vector3D, Line) - Constructor for class org.hipparchus.geometry.euclidean.threed.Segment
-
Build a segment.
- Segment(Vector2D, Vector2D, Line) - Constructor for class org.hipparchus.geometry.euclidean.twod.Segment
-
Build a segment.
- select(double[], int[], int) - Method in class org.hipparchus.util.KthSelector
-
Select Kth value in the array.
- selectFarthest(Iterable<P>, EnclosingBall<S, P>) - Method in class org.hipparchus.geometry.enclosing.WelzlEncloser
-
Select the point farthest to the current ball.
- selectTransformer(Transformer, double, boolean) - Method in enum org.hipparchus.ode.events.FilterType
-
Get next function transformer in the specified direction.
- SemiVariance - Class in org.hipparchus.stat.descriptive.moment
-
Computes the semivariance of a set of values with respect to a given cutoff value.
- SemiVariance() - Constructor for class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with default (true) biasCorrected
property and default (Downside) varianceDirection
property.
- SemiVariance(boolean) - Constructor for class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with the specified biasCorrected
property and default (Downside) varianceDirection
property.
- SemiVariance(boolean, SemiVariance.Direction) - Constructor for class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with the specified isBiasCorrected
property and the specified Direction
property.
- SemiVariance(SemiVariance) - Constructor for class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Copy constructor, creates a new SemiVariance
identical
to the original
.
- SemiVariance(SemiVariance.Direction) - Constructor for class org.hipparchus.stat.descriptive.moment.SemiVariance
-
Constructs a SemiVariance with the specified Direction
property
and default (true) biasCorrected
property
- SemiVariance.Direction - Enum in org.hipparchus.stat.descriptive.moment
-
The direction of the semivariance - either upside or downside.
- sequence(int, int, int) - Static method in class org.hipparchus.util.MathArrays
-
Returns an array of size
integers starting at start
,
skipping stride
numbers.
- SEQUENTIAL - org.hipparchus.stat.ranking.TiesStrategy
-
Ties assigned sequential ranks in order of occurrence
- serializeRealMatrix(RealMatrix, ObjectOutputStream) - Static method in class org.hipparchus.linear.MatrixUtils
-
- serializeRealVector(RealVector, ObjectOutputStream) - Static method in class org.hipparchus.linear.MatrixUtils
-
- set(double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Set all elements to a single value.
- set(double) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Set all elements to a single value.
- set(double) - Method in class org.hipparchus.linear.RealVector
-
Set all elements to a single value.
- set(int, ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Set a set of consecutive elements.
- set(T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Set all elements to a single value.
- set(T) - Method in interface org.hipparchus.linear.FieldVector
-
Set all elements to a single value.
- set(T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Set all elements to a single value.
- setAngle(double) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Set the angle of the line.
- setAttribute(Object) - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Associate an attribute with the instance.
- setBarycenter(Point<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Set the barycenter of the instance.
- setBarycenter(Vector<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Set the barycenter of the instance.
- setColumn(int, double[]) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Sets the specified column
of this
matrix to the entries
of the specified array
.
- setColumn(int, double[]) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified column
of this
matrix to the entries
of the specified array
.
- setColumn(int, double[]) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified column
of this
matrix to the entries
of the specified array
.
- setColumn(int, T[]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumn(int, T[]) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumn(int, T[]) - Method in interface org.hipparchus.linear.FieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumnMatrix(int, FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumnMatrix(int, FieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumnMatrix(int, FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Set the entries in column number column
as a column matrix.
- setColumnMatrix(int, RealMatrix) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Sets the specified column
of this
matrix to the entries
of the specified column matrix
.
- setColumnMatrix(int, RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified column
of this
matrix to the entries
of the specified column matrix
.
- setColumnMatrix(int, RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified column
of this
matrix to the entries
of the specified column matrix
.
- setColumnVector(int, FieldVector<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Set the entries in column number column
as a vector.
- setColumnVector(int, FieldVector<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Set the entries in column number column
as a vector.
- setColumnVector(int, FieldVector<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Set the entries in column number column
as a vector.
- setColumnVector(int, RealVector) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Sets the specified column
of this
matrix to the entries
of the specified vector
.
- setColumnVector(int, RealVector) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified column
of this
matrix to the entries
of the specified vector
.
- setColumnVector(int, RealVector) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified column
of this
matrix to the entries
of the specified vector
.
- setControlFactors(double, double, double, double) - Method in class org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the step size control factors.
- setData(double[]) - Method in class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Set the data array.
- setData(double[]) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Set the data array.
- setData(double[], int, int) - Method in class org.hipparchus.stat.descriptive.AbstractUnivariateStatistic
-
Set the data array.
- setData(double[], int, int) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Set the data array.
- setElement(int, double) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Sets the element at the specified index.
- setEntry(int, double) - Method in class org.hipparchus.linear.ArrayRealVector
-
Set a single element.
- setEntry(int, double) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Set a single element.
- setEntry(int, double) - Method in class org.hipparchus.linear.RealVector
-
Set a single element.
- setEntry(int, int, double) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, double) - Method in interface org.hipparchus.linear.RealMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, T) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, T) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, T) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, T) - Method in interface org.hipparchus.linear.FieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, int, T) - Method in class org.hipparchus.linear.SparseFieldMatrix
-
Set the entry in the specified row and column.
- setEntry(int, T) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Set a single element.
- setEntry(int, T) - Method in interface org.hipparchus.linear.FieldVector
-
Set a single element.
- setEntry(int, T) - Method in class org.hipparchus.linear.SparseFieldVector
-
Set a single element.
- setIEEEFlags(int) - Method in class org.hipparchus.dfp.DfpField
-
Sets the IEEE 854 status flags.
- setIEEEFlagsBits(int) - Method in class org.hipparchus.dfp.DfpField
-
Sets some bits in the IEEE 854 status flags, without changing the already set bits.
- setIndex(int) - Method in class org.hipparchus.linear.RealVector.Entry
-
Set the index of the entry.
- setInitialMainStateJacobian(double[][]) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.
Set the initial value of the Jacobian matrix with respect to state.
- setInitialMainStateJacobian(double[][]) - Method in class org.hipparchus.ode.VariationalEquation
-
Set the initial value of the Jacobian matrix with respect to state.
- setInitialParameterJacobian(String, double[]) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.
Set the initial value of a column of the Jacobian matrix with respect to one parameter.
- setInitialParameterJacobian(String, double[]) - Method in class org.hipparchus.ode.VariationalEquation
-
Set the initial value of a column of the Jacobian matrix with respect to one parameter.
- setInitialStepSize(double) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the initial step size.
- setInitialStepSize(T) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Set the initial step size.
- setInterpolatedTime(double) - Method in class org.hipparchus.migration.ode.ContinuousOutputModel
-
Deprecated.
Set the time of the interpolated point.
- setInterpolatedTime(double) - Method in interface org.hipparchus.migration.ode.sampling.StepInterpolator
-
- setInterpolationControl(boolean, int) - Method in class org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the interpolation order control parameter.
- setIsLastStep(boolean) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Set the last state flag.
- setIsLastStep(boolean) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Set the last state flag.
- setMaxEvaluations(int) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Set the maximal number of differential equations function evaluations.
- setMaxEvaluations(int) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Set the maximal number of differential equations function evaluations.
- setMaxEvaluations(int) - Method in interface org.hipparchus.ode.FieldODEIntegrator
-
Set the maximal number of differential equations function evaluations.
- setMaxEvaluations(int) - Method in interface org.hipparchus.ode.ODEIntegrator
-
Set the maximal number of differential equations function evaluations.
- setMaxGrowth(double) - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Set the maximal growth factor for stepsize control.
- setMaxGrowth(double) - Method in class org.hipparchus.ode.MultistepIntegrator
-
Set the maximal growth factor for stepsize control.
- setMaxGrowth(double) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Set the maximal growth factor for stepsize control.
- setMaxGrowth(T) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Set the maximal growth factor for stepsize control.
- setMinReduction(double) - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Set the minimal reduction factor for stepsize control.
- setMinReduction(double) - Method in class org.hipparchus.ode.MultistepIntegrator
-
Set the minimal reduction factor for stepsize control.
- setMinReduction(double) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Set the minimal reduction factor for stepsize control.
- setMinReduction(T) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Set the minimal reduction factor for stepsize control.
- setNoIntercept(boolean) - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
- setNumElements(int) - Method in class org.hipparchus.util.ResizableDoubleArray
-
This function allows you to control the number of elements contained
in this array, and can be used to "throw out" the last n values in an
array.
- setOrderControl(int, double, double) - Method in class org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the order control parameters.
- setOriginOffset(double) - Method in class org.hipparchus.geometry.euclidean.twod.Line
-
Set the offset of the origin.
- setParameter(String, double) - Method in interface org.hipparchus.ode.ParametersController
-
Set the value for a given parameter.
- setParameterizedODE(ParametersController) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
- setParametersController(ParametersController) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.
Set a parameter Jacobian provider.
- setParameterStep(String, double) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.
Set the step associated to a parameter in order to compute by finite
difference the Jacobian matrix.
- setPoint(int, PointValuePair) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Store a new point at location index
.
- setPoints(PointValuePair[]) - Method in class org.hipparchus.optim.nonlinear.scalar.noderiv.AbstractSimplex
-
Replace all points.
- setQuantile(double) - Method in class org.hipparchus.stat.descriptive.rank.Percentile
-
Sets the value of the quantile field (determines what percentile is
computed when evaluate() is called with no quantile argument).
- setRoundingMode(RoundingMode) - Method in class org.hipparchus.util.BigReal
-
Sets the rounding mode for decimal divisions.
- setRoundingMode(DfpField.RoundingMode) - Method in class org.hipparchus.dfp.DfpField
-
Set the rounding mode.
- setRow(int, double[]) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Sets the specified row
of this
matrix to the entries
of the specified array
.
- setRow(int, double[]) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Sets the specified row
of this
matrix to the entries
of the specified array
.
- setRow(int, double[]) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified row
of this
matrix to the entries
of the specified array
.
- setRow(int, double[]) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified row
of this
matrix to the entries
of the specified array
.
- setRow(int, T[]) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRow(int, T[]) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRow(int, T[]) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRow(int, T[]) - Method in interface org.hipparchus.linear.FieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRowMatrix(int, BlockFieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Sets the entries in row number row
as a row matrix.
- setRowMatrix(int, BlockRealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the entries in row number row
as a row matrix.
- setRowMatrix(int, FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRowMatrix(int, FieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRowMatrix(int, FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Set the entries in row number row
as a row matrix.
- setRowMatrix(int, RealMatrix) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Sets the specified row
of this
matrix to the entries of
the specified row matrix
.
- setRowMatrix(int, RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified row
of this
matrix to the entries of
the specified row matrix
.
- setRowMatrix(int, RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified row
of this
matrix to the entries of
the specified row matrix
.
- setRowVector(int, FieldVector<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Set the entries in row number row
as a vector.
- setRowVector(int, FieldVector<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Set the entries in row number row
as a vector.
- setRowVector(int, FieldVector<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Set the entries in row number row
as a vector.
- setRowVector(int, RealVector) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Sets the specified row
of this
matrix to the entries of
the specified vector
.
- setRowVector(int, RealVector) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Sets the specified row
of this
matrix to the entries of
the specified vector
.
- setRowVector(int, RealVector) - Method in interface org.hipparchus.linear.RealMatrix
-
Sets the specified row
of this
matrix to the entries of
the specified vector
.
- setSafety(double) - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Set the safety factor for stepsize control.
- setSafety(double) - Method in class org.hipparchus.ode.MultistepIntegrator
-
Set the safety factor for stepsize control.
- setSafety(double) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaIntegrator
-
Set the safety factor for stepsize control.
- setSafety(T) - Method in class org.hipparchus.ode.nonstiff.EmbeddedRungeKuttaFieldIntegrator
-
Set the safety factor for stepsize control.
- setScale(int) - Method in class org.hipparchus.util.BigReal
-
Sets the scale for division operations.
- setSeed(int) - Method in class org.hipparchus.random.JDKRandomGenerator
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(int) - Method in class org.hipparchus.random.MersenneTwister
-
Reinitialize the generator as if just built with the given int seed.
- setSeed(int) - Method in class org.hipparchus.random.RandomAdaptor
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(int) - Method in interface org.hipparchus.random.RandomGenerator
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(int) - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Sets the seed of the underlying random number generator using an
int
seed.
- setSeed(int[]) - Method in class org.hipparchus.random.AbstractWell
-
Reinitialize the generator as if just built with the given int array seed.
- setSeed(int[]) - Method in class org.hipparchus.random.ISAACRandom
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(int[]) - Method in class org.hipparchus.random.JDKRandomGenerator
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(int[]) - Method in class org.hipparchus.random.MersenneTwister
-
Reinitialize the generator as if just built with the given int array seed.
- setSeed(int[]) - Method in class org.hipparchus.random.RandomAdaptor
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(int[]) - Method in interface org.hipparchus.random.RandomGenerator
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(int[]) - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Sets the seed of the underlying random number generator using an
int
array seed.
- setSeed(long) - Method in class org.hipparchus.random.JDKRandomGenerator
-
Sets the seed of the underlying random number generator using a
long
seed.
- setSeed(long) - Method in class org.hipparchus.random.RandomAdaptor
-
Sets the seed of the underlying random number generator using a
long
seed.
- setSeed(long) - Method in interface org.hipparchus.random.RandomGenerator
-
Sets the seed of the underlying random number generator using a
long
seed.
- setSeed(long) - Method in class org.hipparchus.random.SynchronizedRandomGenerator
-
Sets the seed of the underlying random number generator using a
long
seed.
- setSize(double) - Method in class org.hipparchus.geometry.partitioning.AbstractRegion
-
Set the size of the instance.
- setStabilityCheck(boolean, int, int, double) - Method in class org.hipparchus.ode.nonstiff.GraggBulirschStoerIntegrator
-
Set the stability check controls.
- setStarterIntegrator(FieldODEIntegrator<T>) - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Set the starter integrator.
- setStarterIntegrator(ODEIntegrator) - Method in class org.hipparchus.ode.MultistepIntegrator
-
Set the starter integrator.
- setStateInitialized(boolean) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Set the stateInitialized flag.
- setStateInitialized(boolean) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Set the stateInitialized flag.
- setStepSize(double) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Set the current step size.
- setStepSize(T) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Set the current step size.
- setStepSizeControl(double, double, double[], double[]) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Set the adaptive step size control parameters.
- setStepSizeControl(double, double, double[], double[]) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the adaptive step size control parameters.
- setStepSizeControl(double, double, double, double) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Set the adaptive step size control parameters.
- setStepSizeControl(double, double, double, double) - Method in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Set the adaptive step size control parameters.
- setStepStart(FieldODEStateAndDerivative<T>) - Method in class org.hipparchus.ode.AbstractFieldIntegrator
-
Set current step start.
- setStepStart(ODEStateAndDerivative) - Method in class org.hipparchus.ode.AbstractIntegrator
-
Set current step start.
- setSubMatrix(double[][], int, int) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Replace the submatrix starting at row, column
using data in the
input subMatrix
array.
- setSubMatrix(double[][], int, int) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Replace the submatrix starting at row, column
using data in the
input subMatrix
array.
- setSubMatrix(double[][], int, int) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Replace the submatrix starting at row, column
using data in the
input subMatrix
array.
- setSubMatrix(double[][], int, int) - Method in interface org.hipparchus.linear.RealMatrix
-
Replace the submatrix starting at row, column
using data in the
input subMatrix
array.
- setSubMatrix(T[][], int, int) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Replace the submatrix starting at (row, column)
using data in the
input subMatrix
array.
- setSubMatrix(T[][], int, int) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Replace the submatrix starting at (row, column)
using data in the
input subMatrix
array.
- setSubMatrix(T[][], int, int) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Replace the submatrix starting at (row, column)
using data in the
input subMatrix
array.
- setSubMatrix(T[][], int, int) - Method in interface org.hipparchus.linear.FieldMatrix
-
Replace the submatrix starting at (row, column)
using data in the
input subMatrix
array.
- setSubVector(int, double[]) - Method in class org.hipparchus.linear.ArrayRealVector
-
Set a set of consecutive elements.
- setSubVector(int, FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Set a set of consecutive elements.
- setSubVector(int, FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Set a set of consecutive elements.
- setSubVector(int, FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Set a set of consecutive elements.
- setSubVector(int, RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Set a sequence of consecutive elements.
- setSubVector(int, RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Set a sequence of consecutive elements.
- setSubVector(int, RealVector) - Method in class org.hipparchus.linear.RealVector
-
Set a sequence of consecutive elements.
- setup(int, FUNC, double, double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Prepare for computation.
- setup(int, UnivariateDifferentiableFunction, double, double, double) - Method in class org.hipparchus.analysis.solvers.AbstractUnivariateDifferentiableSolver
-
Prepare for computation.
- setup(int, PolynomialFunction, double, double, double) - Method in class org.hipparchus.analysis.solvers.AbstractPolynomialSolver
-
Prepare for computation.
- setup(int, UnivariateFunction, double, double) - Method in class org.hipparchus.analysis.integration.BaseAbstractUnivariateIntegrator
-
Prepare for computation.
- setUpInitialState(ODEState) - Method in class org.hipparchus.migration.ode.JacobianMatrices
-
Deprecated.
Set up initial state.
- setUpInitialState(ODEState) - Method in class org.hipparchus.ode.VariationalEquation
-
Set up initial state.
- setValue(double) - Method in class org.hipparchus.linear.OpenMapRealVector.OpenMapEntry
-
Set the value of the entry.
- setValue(double) - Method in class org.hipparchus.linear.RealVector.Entry
-
Set the value of the entry.
- setWindowSize(int) - Method in class org.hipparchus.stat.descriptive.DescriptiveStatistics
-
WindowSize controls the number of values that contribute to the
reported statistics.
- SHAPE - org.hipparchus.exception.LocalizedCoreFormats
-
- SHAPE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- shift(double[], double) - Static method in class org.hipparchus.analysis.polynomials.PolynomialsUtils
-
Compute the coefficients of the polynomial \(P_s(x)\)
whose values at point x
will be the same as the those from the
original polynomial \(P(x)\) when computed at x + shift
.
- shiftLeft() - Method in class org.hipparchus.dfp.Dfp
-
Shift the mantissa left, and adjust the exponent to compensate.
- shiftRight() - Method in class org.hipparchus.dfp.Dfp
-
Shift the mantissa right, and adjust the exponent to compensate.
- shortValue() - Method in class org.hipparchus.util.Decimal64
-
The current implementation performs casting to a short
.
- showExampleFrame(ExampleUtils.ExampleFrame) - Static method in class org.hipparchus.samples.ExampleUtils
-
- shuffle(int[]) - Static method in class org.hipparchus.util.MathArrays
-
Shuffle the entries of the given array.
- shuffle(int[], int, MathArrays.Position) - Static method in class org.hipparchus.util.MathArrays
-
Shuffle the entries of the given array.
- shuffle(int[], int, MathArrays.Position, RandomGenerator) - Static method in class org.hipparchus.util.MathArrays
-
Shuffle the entries of the given array, using the
Fisher–Yates algorithm.
- shuffle(int[], RandomGenerator) - Static method in class org.hipparchus.util.MathArrays
-
Shuffle the entries of the given array.
- side(Arc) - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet
-
- Side - Enum in org.hipparchus.geometry.partitioning
-
Enumerate representing the location of an element with respect to an
hyperplane
of a space.
- Sigma(double[]) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.CMAESOptimizer.Sigma
-
- Sigmoid - Class in org.hipparchus.analysis.function
-
- Sigmoid() - Constructor for class org.hipparchus.analysis.function.Sigmoid
-
Usual sigmoid function, where the lower asymptote is 0 and the higher
asymptote is 1.
- Sigmoid(double, double) - Constructor for class org.hipparchus.analysis.function.Sigmoid
-
Sigmoid function.
- Sigmoid.Parametric - Class in org.hipparchus.analysis.function
-
Parametric function where the input array contains the parameters of
the
sigmoid function
, ordered
as follows:
Lower asymptote
Higher asymptote
- sign - Variable in class org.hipparchus.dfp.Dfp
-
Sign bit: 1 for positive, -1 for negative.
- SIGNIFICANCE_LEVEL - org.hipparchus.exception.LocalizedCoreFormats
-
Deprecated.
- SIGNIFICANCE_LEVEL - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- SIGNIFICANCE_LEVEL - org.hipparchus.stat.LocalizedStatFormats
-
- signum() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute the signum of the instance.
- signum() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute the signum of the instance.
- signum() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute the signum of the instance.
- signum() - Method in class org.hipparchus.dfp.Dfp
-
Compute the signum of the instance.
- signum() - Method in interface org.hipparchus.RealFieldElement
-
Compute the signum of the instance.
- signum() - Method in class org.hipparchus.util.Decimal64
-
Compute the signum of the instance.
- signum() - Method in class org.hipparchus.util.FieldTuple
-
Compute the signum of the instance.
- signum() - Method in class org.hipparchus.util.Tuple
-
Compute the signum of the instance.
- signum(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the signum of a number.
- signum(float) - Static method in class org.hipparchus.util.FastMath
-
Compute the signum of a number.
- signum(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the signum of a number.
- Signum - Class in org.hipparchus.analysis.function
-
signum
function.
- Signum() - Constructor for class org.hipparchus.analysis.function.Signum
-
- SIMPLE_MESSAGE - org.hipparchus.exception.LocalizedCoreFormats
-
- SIMPLE_MESSAGE - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- SimpleBounds - Class in org.hipparchus.optim
-
Simple optimization constraints: lower and upper bounds.
- SimpleBounds(double[], double[]) - Constructor for class org.hipparchus.optim.SimpleBounds
-
- SimpleCurveFitter - Class in org.hipparchus.fitting
-
- SimplePointChecker<PAIR extends Pair<double[],? extends Object>> - Class in org.hipparchus.optim
-
- SimplePointChecker(double, double) - Constructor for class org.hipparchus.optim.SimplePointChecker
-
Build an instance with specified thresholds.
- SimplePointChecker(double, double, int) - Constructor for class org.hipparchus.optim.SimplePointChecker
-
Builds an instance with specified thresholds.
- SimpleRegression - Class in org.hipparchus.stat.regression
-
Estimates an ordinary least squares regression model
with one independent variable.
- SimpleRegression() - Constructor for class org.hipparchus.stat.regression.SimpleRegression
-
Create an empty SimpleRegression instance
- SimpleRegression(boolean) - Constructor for class org.hipparchus.stat.regression.SimpleRegression
-
Create a SimpleRegression instance, specifying whether or not to estimate
an intercept.
- SimpleUnivariateValueChecker - Class in org.hipparchus.optim.univariate
-
Simple implementation of the
ConvergenceChecker
interface
that uses only objective function values.
- SimpleUnivariateValueChecker(double, double) - Constructor for class org.hipparchus.optim.univariate.SimpleUnivariateValueChecker
-
Build an instance with specified thresholds.
- SimpleUnivariateValueChecker(double, double, int) - Constructor for class org.hipparchus.optim.univariate.SimpleUnivariateValueChecker
-
Builds an instance with specified thresholds.
- SimpleValueChecker - Class in org.hipparchus.optim
-
Simple implementation of the
ConvergenceChecker
interface using
only objective function values.
- SimpleValueChecker(double, double) - Constructor for class org.hipparchus.optim.SimpleValueChecker
-
Build an instance with specified thresholds.
- SimpleValueChecker(double, double, int) - Constructor for class org.hipparchus.optim.SimpleValueChecker
-
Builds an instance with specified thresholds.
- SimpleVectorValueChecker - Class in org.hipparchus.optim
-
Simple implementation of the
ConvergenceChecker
interface using
only objective function values.
- SimpleVectorValueChecker(double, double) - Constructor for class org.hipparchus.optim.SimpleVectorValueChecker
-
Build an instance with specified thresholds.
- SimpleVectorValueChecker(double, double, int) - Constructor for class org.hipparchus.optim.SimpleVectorValueChecker
-
Builds an instance with specified tolerance thresholds and
iteration count.
- SIMPLEX_NEED_ONE_POINT - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- SIMPLEX_NEED_ONE_POINT - org.hipparchus.optim.LocalizedOptimFormats
-
- SimplexOptimizer - Class in org.hipparchus.optim.nonlinear.scalar.noderiv
-
This class implements simplex-based direct search optimization.
- SimplexOptimizer(double, double) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
- SimplexOptimizer(ConvergenceChecker<PointValuePair>) - Constructor for class org.hipparchus.optim.nonlinear.scalar.noderiv.SimplexOptimizer
-
- SimplexSolver - Class in org.hipparchus.optim.linear
-
Solves a linear problem using the "Two-Phase Simplex" method.
- SimplexSolver() - Constructor for class org.hipparchus.optim.linear.SimplexSolver
-
Builds a simplex solver with default settings.
- SimplexSolver(double) - Constructor for class org.hipparchus.optim.linear.SimplexSolver
-
Builds a simplex solver with a specified accepted amount of error.
- SimplexSolver(double, int) - Constructor for class org.hipparchus.optim.linear.SimplexSolver
-
Builds a simplex solver with a specified accepted amount of error.
- SimplexSolver(double, int, double) - Constructor for class org.hipparchus.optim.linear.SimplexSolver
-
Builds a simplex solver with a specified accepted amount of error.
- SIMPSON_MAX_ITERATIONS_COUNT - Static variable in class org.hipparchus.analysis.integration.SimpsonIntegrator
-
Maximal number of iterations for Simpson.
- SimpsonIntegrator - Class in org.hipparchus.analysis.integration
-
Implements
Simpson's Rule for integration of real univariate functions.
- SimpsonIntegrator() - Constructor for class org.hipparchus.analysis.integration.SimpsonIntegrator
-
Construct an integrator with default settings.
- SimpsonIntegrator(double, double, int, int) - Constructor for class org.hipparchus.analysis.integration.SimpsonIntegrator
-
Build a Simpson integrator with given accuracies and iterations counts.
- SimpsonIntegrator(int, int) - Constructor for class org.hipparchus.analysis.integration.SimpsonIntegrator
-
Build a Simpson integrator with given iteration counts.
- sin() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Sine operation.
- sin() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Sine operation.
- sin() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Sine operation.
- sin() - Method in class org.hipparchus.complex.Complex
-
Compute the
sine
of this complex number.
- sin() - Method in class org.hipparchus.dfp.Dfp
-
Sine operation.
- sin() - Method in interface org.hipparchus.RealFieldElement
-
Sine operation.
- sin() - Method in class org.hipparchus.util.Decimal64
-
Sine operation.
- sin() - Method in class org.hipparchus.util.FieldTuple
-
Sine operation.
- sin() - Method in class org.hipparchus.util.SinCos
-
Get the value of the sine.
- sin() - Method in class org.hipparchus.util.Tuple
-
Sine operation.
- sin(double) - Static method in class org.hipparchus.util.FastMath
-
Sine function.
- sin(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute sine of a derivative structure.
- sin(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
computes the sine of the argument.
- sin(T) - Static method in class org.hipparchus.util.FastMath
-
Sine function.
- sin(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute sine of a derivative structure.
- Sin - Class in org.hipparchus.analysis.function
-
Sine function.
- Sin() - Constructor for class org.hipparchus.analysis.function.Sin
-
- Sinc - Class in org.hipparchus.analysis.function
-
Sinc function,
defined by
- Sinc() - Constructor for class org.hipparchus.analysis.function.Sinc
-
The sinc function, sin(x) / x
.
- Sinc(boolean) - Constructor for class org.hipparchus.analysis.function.Sinc
-
Instantiates the sinc function.
- sinCos(double) - Static method in class org.hipparchus.util.FastMath
-
Combined Sine and Cosine function.
- SinCos - Class in org.hipparchus.util
-
Holder for both sin and cosine values.
- singleStep(FieldOrdinaryDifferentialEquation<T>, T, T[], T) - Method in class org.hipparchus.ode.nonstiff.RungeKuttaFieldIntegrator
-
Fast computation of a single step of ODE integration.
- singleStep(OrdinaryDifferentialEquation, double, double[], double) - Method in class org.hipparchus.ode.nonstiff.RungeKuttaIntegrator
-
Fast computation of a single step of ODE integration.
- SINGULAR_MATRIX - org.hipparchus.exception.LocalizedCoreFormats
-
- SINGULAR_MATRIX - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- SINGULAR_OPERATOR - org.hipparchus.exception.LocalizedCoreFormats
-
- SINGULAR_OPERATOR - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- SingularMatrixException - Exception in org.hipparchus.migration.linear
-
- SingularMatrixException() - Constructor for exception org.hipparchus.migration.linear.SingularMatrixException
-
Deprecated.
Construct an exception.
- SingularOperatorException - Exception in org.hipparchus.migration.linear
-
- SingularOperatorException() - Constructor for exception org.hipparchus.migration.linear.SingularOperatorException
-
Deprecated.
Creates a new instance of this class.
- SingularValueDecomposer - Class in org.hipparchus.linear
-
Matrix decomposer using Singular Value Decomposition.
- SingularValueDecomposer() - Constructor for class org.hipparchus.linear.SingularValueDecomposer
-
Creates a singular value decomposer.
- SingularValueDecomposition - Class in org.hipparchus.linear
-
Calculates the compact Singular Value Decomposition of a matrix.
- SingularValueDecomposition(RealMatrix) - Constructor for class org.hipparchus.linear.SingularValueDecomposition
-
Calculates the compact Singular Value Decomposition of the given matrix.
- sinh() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.complex.Complex
-
- sinh() - Method in class org.hipparchus.dfp.Dfp
-
Hyperbolic sine operation.
- sinh() - Method in interface org.hipparchus.RealFieldElement
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.util.Decimal64
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.util.FieldTuple
-
Hyperbolic sine operation.
- sinh() - Method in class org.hipparchus.util.Tuple
-
Hyperbolic sine operation.
- sinh(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the hyperbolic sine of a number.
- sinh(double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute hyperbolic sine of a derivative structure.
- sinh(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the hyperbolic sine of a number.
- sinh(T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Compute hyperbolic sine of a derivative structure.
- Sinh - Class in org.hipparchus.analysis.function
-
Hyperbolic sine function.
- Sinh() - Constructor for class org.hipparchus.analysis.function.Sinh
-
- sinInternal(Dfp[]) - Static method in class org.hipparchus.dfp.DfpMath
-
Computes sin(a) Used when 0 < a < pi/4.
- size() - Method in class org.hipparchus.util.OpenIntToDoubleHashMap
-
Get the number of elements stored in the map.
- size() - Method in class org.hipparchus.util.OpenIntToFieldHashMap
-
Get the number of elements stored in the map.
- Skewness - Class in org.hipparchus.stat.descriptive.moment
-
Computes the skewness of the available values.
- Skewness() - Constructor for class org.hipparchus.stat.descriptive.moment.Skewness
-
Constructs a Skewness.
- Skewness(Skewness) - Constructor for class org.hipparchus.stat.descriptive.moment.Skewness
-
Copy constructor, creates a new Skewness
identical
to the original
.
- Skewness(ThirdMoment) - Constructor for class org.hipparchus.stat.descriptive.moment.Skewness
-
Constructs a Skewness with an external moment.
- skipTo(int) - Method in class org.hipparchus.random.HaltonSequenceGenerator
-
Skip to the i-th point in the Halton sequence.
- skipTo(int) - Method in class org.hipparchus.random.SobolSequenceGenerator
-
Skip to the i-th point in the Sobol sequence.
- smooth(double[], double[]) - Method in class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Compute a loess fit on the data at the original abscissae.
- smooth(double[], double[], double[]) - Method in class org.hipparchus.analysis.interpolation.LoessInterpolator
-
Compute a weighted loess fit on the data at the original abscissae.
- SNAN - Static variable in class org.hipparchus.dfp.Dfp
-
Indicator value for signaling NaN.
- SobolSequenceGenerator - Class in org.hipparchus.random
-
Implementation of a Sobol sequence.
- SobolSequenceGenerator(int) - Constructor for class org.hipparchus.random.SobolSequenceGenerator
-
Construct a new Sobol sequence generator for the given space dimension.
- SobolSequenceGenerator(int, InputStream) - Constructor for class org.hipparchus.random.SobolSequenceGenerator
-
Construct a new Sobol sequence generator for the given space dimension with
direction vectors loaded from the given stream.
- SolutionCallback - Class in org.hipparchus.optim.linear
-
A callback object that can be provided to a linear optimizer to keep track
of the best solution found.
- SolutionCallback() - Constructor for class org.hipparchus.optim.linear.SolutionCallback
-
- solve(int, FUNC, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Solve for a zero in the vicinity of startValue
.
- solve(int, FUNC, double) - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Solve for a zero in the vicinity of startValue
.
- solve(int, FUNC, double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Solve for a zero root in the given interval.
- solve(int, FUNC, double, double) - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Solve for a zero root in the given interval.
- solve(int, FUNC, double, double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, FUNC, double, double, double) - Method in interface org.hipparchus.analysis.solvers.BaseUnivariateSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, FUNC, double, double, double, AllowedSolution) - Method in interface org.hipparchus.analysis.solvers.BracketedUnivariateSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, FUNC, double, double, AllowedSolution) - Method in interface org.hipparchus.analysis.solvers.BracketedUnivariateSolver
-
Solve for a zero in the given interval.
- solve(int, UnivariateDifferentiableFunction, double, double) - Method in class org.hipparchus.analysis.solvers.NewtonRaphsonSolver
-
Find a zero near the midpoint of min
and max
.
- solve(int, RealFieldUnivariateFunction<T>, T, T, AllowedSolution) - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Solve for a zero in the given interval.
- solve(int, RealFieldUnivariateFunction<T>, T, T, AllowedSolution) - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Solve for a zero in the given interval.
- solve(int, RealFieldUnivariateFunction<T>, T, T, T, AllowedSolution) - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, RealFieldUnivariateFunction<T>, T, T, T, AllowedSolution) - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, UnivariateFunction, double, double, double) - Method in class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, UnivariateFunction, double, double, double, AllowedSolution) - Method in class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Solve for a zero in the given interval, start at startValue
.
- solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Solve for a zero in the given interval.
- solve(int, UnivariateFunction, double, double, AllowedSolution) - Method in class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Solve for a zero in the given interval.
- solve(UnivariateFunction, double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Convenience method to find a zero of a univariate real function.
- solve(UnivariateFunction, double, double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Convenience method to find a zero of a univariate real function.
- solve(FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldDecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldDecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector) - Method in class org.hipparchus.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector, boolean, double) - Method in class org.hipparchus.linear.SymmLQ
-
Returns an estimate of the solution to the linear system (A - shift
· I) · x = b.
- solve(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector) - Method in class org.hipparchus.linear.IterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector) - Method in class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector) - Method in class org.hipparchus.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector, boolean, double) - Method in class org.hipparchus.linear.SymmLQ
-
Returns the solution to the system (A - shift · I) · x = b.
- solve(RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.IterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solve(RealMatrix) - Method in interface org.hipparchus.linear.DecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solve(RealMatrix, RealVector) - Method in enum org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer.Decomposition
-
Deprecated.
Solve the linear least squares problem Jx=r.
- solve(RealVector) - Method in interface org.hipparchus.linear.DecompositionSolver
-
Solve the linear equation A × X = B for matrices A.
- solveAllComplex(double[], double) - Method in class org.hipparchus.analysis.solvers.LaguerreSolver
-
Find all complex roots for the polynomial with the given
coefficients, starting from the given initial value.
- solveComplex(double[], double) - Method in class org.hipparchus.analysis.solvers.LaguerreSolver
-
Find a complex root for the polynomial with the given coefficients,
starting from the given initial value.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.ConjugateGradient
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealLinearOperator, RealVector, RealVector, boolean, double) - Method in class org.hipparchus.linear.SymmLQ
-
Returns an estimate of the solution to the linear system (A - shift
· I) · x = b.
- solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.IterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.PreconditionedIterativeLinearSolver
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInPlace(RealLinearOperator, RealVector, RealVector) - Method in class org.hipparchus.linear.SymmLQ
-
Returns an estimate of the solution to the linear system A · x =
b.
- solveInterval(int, FUNC, double, double) - Method in interface org.hipparchus.analysis.solvers.BracketedUnivariateSolver
-
Solve for a zero in the given interval and return a tolerance interval surrounding
the root.
- solveInterval(int, FUNC, double, double, double) - Method in interface org.hipparchus.analysis.solvers.BracketedUnivariateSolver
-
Solve for a zero in the given interval and return a tolerance interval surrounding
the root.
- solveInterval(int, RealFieldUnivariateFunction<T>, T, T) - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Solve for a zero in the given interval and return a tolerance interval surrounding
the root.
- solveInterval(int, RealFieldUnivariateFunction<T>, T, T, T) - Method in interface org.hipparchus.analysis.solvers.BracketedRealFieldUnivariateSolver
-
Solve for a zero in the given interval and return a tolerance interval surrounding
the root.
- solveInterval(int, RealFieldUnivariateFunction<T>, T, T, T) - Method in class org.hipparchus.analysis.solvers.FieldBracketingNthOrderBrentSolver
-
Solve for a zero in the given interval and return a tolerance interval surrounding
the root.
- solveInterval(int, UnivariateFunction, double, double, double) - Method in class org.hipparchus.analysis.solvers.BaseSecantSolver
-
Solve for a zero in the given interval and return a tolerance interval surrounding
the root.
- solveInterval(int, UnivariateFunction, double, double, double) - Method in class org.hipparchus.analysis.solvers.BracketingNthOrderBrentSolver
-
Solve for a zero in the given interval and return a tolerance interval surrounding
the root.
- solveInverseCumulativeProbability(double, int, int) - Method in class org.hipparchus.distribution.discrete.AbstractIntegerDistribution
-
- solveLowerTriangularSystem(RealMatrix, RealVector) - Static method in class org.hipparchus.linear.MatrixUtils
-
Solve a system of composed of a Lower Triangular Matrix
RealMatrix
.
- solvePhase1(SimplexTableau) - Method in class org.hipparchus.optim.linear.SimplexSolver
-
Solves Phase 1 of the Simplex method.
- solveUpperTriangularSystem(RealMatrix, RealVector) - Static method in class org.hipparchus.linear.MatrixUtils
-
Solver a system composed of an Upper Triangular Matrix
RealMatrix
.
- sortInPlace(double[], double[]...) - Static method in class org.hipparchus.util.MathArrays
-
Sort an array in ascending order in place and perform the same reordering
of entries on other arrays.
- sortInPlace(double[], MathArrays.OrderDirection, double[]...) - Static method in class org.hipparchus.util.MathArrays
-
Sort an array in place and perform the same reordering of entries on
other arrays.
- Space - Interface in org.hipparchus.geometry
-
This interface represents a generic space, with affine and vectorial counterparts.
- SparseEntryIterator() - Constructor for class org.hipparchus.linear.RealVector.SparseEntryIterator
-
Simple constructor.
- SparseFieldMatrix<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
Sparse matrix implementation based on an open addressed map.
- SparseFieldMatrix(Field<T>) - Constructor for class org.hipparchus.linear.SparseFieldMatrix
-
Create a matrix with no data.
- SparseFieldMatrix(Field<T>, int, int) - Constructor for class org.hipparchus.linear.SparseFieldMatrix
-
Create a new SparseFieldMatrix with the supplied row and column
dimensions.
- SparseFieldMatrix(FieldMatrix<T>) - Constructor for class org.hipparchus.linear.SparseFieldMatrix
-
Generic copy constructor.
- SparseFieldMatrix(SparseFieldMatrix<T>) - Constructor for class org.hipparchus.linear.SparseFieldMatrix
-
Copy constructor.
- SparseFieldVector<T extends FieldElement<T>> - Class in org.hipparchus.linear
-
- SparseFieldVector(Field<T>) - Constructor for class org.hipparchus.linear.SparseFieldVector
-
Build a 0-length vector.
- SparseFieldVector(Field<T>, int) - Constructor for class org.hipparchus.linear.SparseFieldVector
-
Construct a vector of zeroes.
- SparseFieldVector(Field<T>, int, int) - Constructor for class org.hipparchus.linear.SparseFieldVector
-
Build a vector with known the sparseness (for advanced use only).
- SparseFieldVector(Field<T>, T[]) - Constructor for class org.hipparchus.linear.SparseFieldVector
-
Create from a Field array.
- SparseFieldVector(SparseFieldVector<T>) - Constructor for class org.hipparchus.linear.SparseFieldVector
-
Copy constructor.
- SparseFieldVector(SparseFieldVector<T>, int) - Constructor for class org.hipparchus.linear.SparseFieldVector
-
Build a resized vector, for use with append.
- SparseGradient - Class in org.hipparchus.analysis.differentiation
-
First derivative computation with large number of variables.
- sparseIterator() - Method in class org.hipparchus.linear.OpenMapRealVector
-
Create a sparse iterator over the vector, which may omit some entries.
- sparseIterator() - Method in class org.hipparchus.linear.RealVector
-
Create a sparse iterator over the vector, which may omit some entries.
- SparseRealMatrix - Interface in org.hipparchus.linear
-
Marker interface for
RealMatrix
implementations that require sparse backing storage
- SparseRealVector - Class in org.hipparchus.linear
-
Marker class for RealVectors that require sparse backing storage
- SparseRealVector() - Constructor for class org.hipparchus.linear.SparseRealVector
-
- SpearmansCorrelation - Class in org.hipparchus.stat.correlation
-
Spearman's rank correlation.
- SpearmansCorrelation() - Constructor for class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation without data.
- SpearmansCorrelation(RealMatrix) - Constructor for class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation from the given data matrix.
- SpearmansCorrelation(RealMatrix, RankingAlgorithm) - Constructor for class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation with the given input data matrix
and ranking algorithm.
- SpearmansCorrelation(RankingAlgorithm) - Constructor for class org.hipparchus.stat.correlation.SpearmansCorrelation
-
Create a SpearmansCorrelation with the given ranking algorithm.
- Sphere1D - Class in org.hipparchus.geometry.spherical.oned
-
This class implements a one-dimensional sphere (i.e.
- Sphere1D.NoSubSpaceException - Exception in org.hipparchus.geometry.spherical.oned
-
Specialized exception for inexistent sub-space.
- Sphere2D - Class in org.hipparchus.geometry.spherical.twod
-
This class implements a two-dimensional sphere (i.e.
- SphereGenerator - Class in org.hipparchus.geometry.euclidean.threed
-
Class generating an enclosing ball from its support points.
- SphereGenerator() - Constructor for class org.hipparchus.geometry.euclidean.threed.SphereGenerator
-
- SphericalCoordinates - Class in org.hipparchus.geometry.euclidean.threed
-
- SphericalCoordinates(double, double, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
-
Build a spherical coordinates transformer from spherical coordinates.
- SphericalCoordinates(Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.SphericalCoordinates
-
Build a spherical coordinates transformer from Cartesian coordinates.
- SphericalPolygonsSet - Class in org.hipparchus.geometry.spherical.twod
-
This class represents a region on the 2-sphere: a set of spherical polygons.
- SphericalPolygonsSet(double) - Constructor for class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Build a polygons set representing the whole real 2-sphere.
- SphericalPolygonsSet(double, S2Point...) - Constructor for class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Build a polygon from a simple list of vertices.
- SphericalPolygonsSet(Collection<SubHyperplane<Sphere2D>>, double) - Constructor for class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Build a polygons set from a Boundary REPresentation (B-rep).
- SphericalPolygonsSet(Vector3D, double) - Constructor for class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Build a polygons set representing a hemisphere.
- SphericalPolygonsSet(Vector3D, Vector3D, double, int, double) - Constructor for class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Build a polygons set representing a regular polygon.
- SphericalPolygonsSet(BSPTree<Sphere2D>, double) - Constructor for class org.hipparchus.geometry.spherical.twod.SphericalPolygonsSet
-
Build a polygons set from a BSP tree.
- SplineInterpolator - Class in org.hipparchus.analysis.interpolation
-
Computes a natural (also known as "free", "unclamped") cubic spline interpolation for the data set.
- SplineInterpolator() - Constructor for class org.hipparchus.analysis.interpolation.SplineInterpolator
-
- split(Dfp) - Static method in class org.hipparchus.dfp.DfpMath
-
Splits a
Dfp
into 2
Dfp
's such that their sum is equal to the input
Dfp
.
- split(DfpField, String) - Static method in class org.hipparchus.dfp.DfpMath
-
Breaks a string representation up into two dfp's.
- split(Hyperplane<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.SubOrientedPoint
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.SubPlane
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.SubLine
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<Sphere1D>) - Method in class org.hipparchus.geometry.spherical.oned.SubLimitAngle
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<Sphere2D>) - Method in class org.hipparchus.geometry.spherical.twod.SubCircle
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<S>) - Method in class org.hipparchus.geometry.partitioning.AbstractSubHyperplane
-
Split the instance in two parts by an hyperplane.
- split(Hyperplane<S>) - Method in interface org.hipparchus.geometry.partitioning.SubHyperplane
-
Split the instance in two parts by an hyperplane.
- split(SubHyperplane<S>) - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Split a BSP tree by an external sub-hyperplane.
- split(Arc) - Method in class org.hipparchus.geometry.spherical.oned.ArcsSet
-
Split the instance in two parts by an arc.
- splitDiv(Dfp[], Dfp[]) - Static method in class org.hipparchus.dfp.DfpMath
-
Divide two numbers that are split in to two pieces that are meant to be added together.
- splitMult(Dfp[], Dfp[]) - Static method in class org.hipparchus.dfp.DfpMath
-
Multiply two numbers that are split in to two pieces that are
meant to be added together.
- splitPow(Dfp[], int) - Static method in class org.hipparchus.dfp.DfpMath
-
Raise a split base to the a power.
- SplitSubHyperplane(SubHyperplane<U>, SubHyperplane<U>) - Constructor for class org.hipparchus.geometry.partitioning.SubHyperplane.SplitSubHyperplane
-
Build a SplitSubHyperplane from its parts.
- sqrt() - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Square root.
- sqrt() - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Square root.
- sqrt() - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Square root.
- sqrt() - Method in class org.hipparchus.complex.Complex
-
- sqrt() - Method in class org.hipparchus.dfp.Dfp
-
Compute the square root.
- sqrt() - Method in class org.hipparchus.linear.JacobiPreconditioner
-
Returns the square root of this
diagonal operator.
- sqrt() - Method in interface org.hipparchus.RealFieldElement
-
Square root.
- sqrt() - Method in class org.hipparchus.util.Decimal64
-
Square root.
- sqrt() - Method in class org.hipparchus.util.FieldTuple
-
Square root.
- sqrt() - Method in class org.hipparchus.util.Tuple
-
Square root.
- sqrt(double) - Static method in class org.hipparchus.util.FastMath
-
Compute the square root of a number.
- sqrt(T) - Static method in class org.hipparchus.util.FastMath
-
Compute the square root of a number.
- Sqrt - Class in org.hipparchus.analysis.function
-
Square-root function.
- Sqrt() - Constructor for class org.hipparchus.analysis.function.Sqrt
-
- sqrt1z() - Method in class org.hipparchus.complex.Complex
-
Compute the
square root of
1 - this2
for this complex
number.
- StableRandomGenerator - Class in org.hipparchus.random
-
This class provides a stable normalized random generator.
- StableRandomGenerator(RandomGenerator, double, double) - Constructor for class org.hipparchus.random.StableRandomGenerator
-
Create a new generator.
- stack() - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Transforms a matrix in a vector (Vectorization).
- STANDARD - org.hipparchus.transform.DftNormalization
-
- STANDARD_DCT_I - org.hipparchus.transform.DctNormalization
-
Should be passed to the constructor of
FastCosineTransformer
to use the
standard normalization convention.
- STANDARD_DEVIATION - org.hipparchus.exception.LocalizedCoreFormats
-
- STANDARD_DEVIATION - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- STANDARD_DST_I - org.hipparchus.transform.DstNormalization
-
Should be passed to the constructor of
FastSineTransformer
to
use the
standard normalization convention.
- StandardDeviation - Class in org.hipparchus.stat.descriptive.moment
-
Computes the sample standard deviation.
- StandardDeviation() - Constructor for class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Constructs a StandardDeviation.
- StandardDeviation(boolean) - Constructor for class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Constructs a StandardDeviation with the specified value for the
isBiasCorrected
property.
- StandardDeviation(boolean, SecondMoment) - Constructor for class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Constructs a StandardDeviation with the specified value for the
isBiasCorrected
property and the supplied external moment.
- StandardDeviation(SecondMoment) - Constructor for class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Constructs a StandardDeviation from an external second moment.
- StandardDeviation(StandardDeviation) - Constructor for class org.hipparchus.stat.descriptive.moment.StandardDeviation
-
Copy constructor, creates a new StandardDeviation
identical
to the original
.
- start(double[]) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the initial guess.
- start(int, int, int) - Method in interface org.hipparchus.linear.FieldVectorChangingVisitor
-
Start visiting a vector.
- start(int, int, int) - Method in interface org.hipparchus.linear.FieldVectorPreservingVisitor
-
Start visiting a vector.
- start(int, int, int) - Method in interface org.hipparchus.linear.RealVectorChangingVisitor
-
Start visiting a vector.
- start(int, int, int) - Method in interface org.hipparchus.linear.RealVectorPreservingVisitor
-
Start visiting a vector.
- start(int, int, int, int, int, int) - Method in class org.hipparchus.linear.DefaultFieldMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in class org.hipparchus.linear.DefaultFieldMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in class org.hipparchus.linear.DefaultRealMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in class org.hipparchus.linear.DefaultRealMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface org.hipparchus.linear.FieldMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface org.hipparchus.linear.FieldMatrixPreservingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface org.hipparchus.linear.RealMatrixChangingVisitor
-
Start visiting a matrix.
- start(int, int, int, int, int, int) - Method in interface org.hipparchus.linear.RealMatrixPreservingVisitor
-
Start visiting a matrix.
- start(RealVector) - Method in class org.hipparchus.optim.nonlinear.vector.leastsquares.LeastSquaresBuilder
-
Configure the initial guess.
- start(ExpandableODE, ODEState, double) - Method in class org.hipparchus.ode.MultistepIntegrator
-
Start the integration.
- start(FieldExpandableODE<T>, FieldODEState<T>, T) - Method in class org.hipparchus.ode.MultistepFieldIntegrator
-
Start the integration.
- START_POINT_NOT_IN_INTERVAL - org.hipparchus.exception.LocalizedCoreFormats
-
- START_POSITION - org.hipparchus.exception.LocalizedCoreFormats
-
- START_POSITION - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- StatisticalMultivariateSummary - Interface in org.hipparchus.stat.descriptive
-
Reporting interface for basic multivariate statistics.
- StatisticalSummary - Interface in org.hipparchus.stat.descriptive
-
Reporting interface for basic univariate statistics.
- StatisticalSummaryValues - Class in org.hipparchus.stat.descriptive
-
Value object representing the results of a univariate
statistical summary.
- StatisticalSummaryValues(double, double, long, double, double, double) - Constructor for class org.hipparchus.stat.descriptive.StatisticalSummaryValues
-
Constructor.
- StatUtils - Class in org.hipparchus.stat
-
StatUtils provides static methods for computing statistics based on data
stored in double[] arrays.
- StepFunction - Class in org.hipparchus.analysis.function
-
- StepFunction(double[], double[]) - Constructor for class org.hipparchus.analysis.function.StepFunction
-
Builds a step function from a list of arguments and the corresponding
values.
- StepHandler - Interface in org.hipparchus.migration.ode.sampling
-
- StepInterpolator - Interface in org.hipparchus.migration.ode.sampling
-
- StepNormalizer - Class in org.hipparchus.ode.sampling
-
- StepNormalizer(double, ODEFixedStepHandler) - Constructor for class org.hipparchus.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizer(double, ODEFixedStepHandler, StepNormalizerBounds) - Constructor for class org.hipparchus.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizer(double, ODEFixedStepHandler, StepNormalizerMode) - Constructor for class org.hipparchus.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizer(double, ODEFixedStepHandler, StepNormalizerMode, StepNormalizerBounds) - Constructor for class org.hipparchus.ode.sampling.StepNormalizer
-
Simple constructor.
- StepNormalizerBounds - Enum in org.hipparchus.ode.sampling
-
- StepNormalizerMode - Enum in org.hipparchus.ode.sampling
-
- stirlingS2(int, int) - Static method in class org.hipparchus.util.CombinatoricsUtils
-
- STOP - org.hipparchus.migration.ode.events.EventHandler.Action
-
Deprecated.
Stop indicator.
- STOP - org.hipparchus.ode.events.Action
-
Stop indicator.
- store(PointValuePair) - Method in class org.hipparchus.optim.nonlinear.scalar.MultiStartMultivariateOptimizer
-
Method that will be called in order to store each found optimum.
- store(PAIR) - Method in class org.hipparchus.optim.BaseMultiStartMultivariateOptimizer
-
Method that will be called in order to store each found optimum.
- StorelessCovariance - Class in org.hipparchus.stat.correlation
-
Covariance implementation that does not require input data to be
stored in memory.
- StorelessCovariance(int) - Constructor for class org.hipparchus.stat.correlation.StorelessCovariance
-
Create a bias corrected covariance matrix with a given dimension.
- StorelessCovariance(int, boolean) - Constructor for class org.hipparchus.stat.correlation.StorelessCovariance
-
Create a covariance matrix with a given number of rows and columns and the
indicated bias correction.
- StorelessMultivariateStatistic - Interface in org.hipparchus.stat.descriptive
-
Base interface implemented by storeless multivariate statistics.
- StorelessUnivariateStatistic - Interface in org.hipparchus.stat.descriptive
-
- StreamingStatistics - Class in org.hipparchus.stat.descriptive
-
Computes summary statistics for a stream of data values added using the
addValue
method.
- StreamingStatistics() - Constructor for class org.hipparchus.stat.descriptive.StreamingStatistics
-
Construct a new StreamingStatistics instance, maintaining all statistics
other than percentiles.
- StreamingStatistics(boolean) - Constructor for class org.hipparchus.stat.descriptive.StreamingStatistics
-
Construct a new StreamingStatistics instance, maintaining all statistics
other than percentiles and with/without percentiles per the argument.
- StreamingStatistics.StreamingStatisticsBuilder - Class in org.hipparchus.stat.descriptive
-
Builder for StreamingStatistics instances.
- StreamingStatisticsBuilder() - Constructor for class org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
-
Simple constructor.
- strictlyNegative() - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is strictly less than 0.
- strictlyPositive() - Method in class org.hipparchus.dfp.Dfp
-
Check if instance is strictly greater than 0.
- SUB_MINUS_PLUS - org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
-
Indicator for visit order cut sub-hyperplane, then minus sub-tree,
and last plus sub-tree.
- SUB_PLUS_MINUS - org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
-
Indicator for visit order cut sub-hyperplane, then plus sub-tree,
and last minus sub-tree.
- subAndCheck(int, int) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Subtract two integers, checking for overflow.
- subAndCheck(long, long) - Static method in class org.hipparchus.util.ArithmeticUtils
-
Subtract two long integers, checking for overflow.
- SUBARRAY_ENDS_AFTER_ARRAY_END - org.hipparchus.exception.LocalizedCoreFormats
-
- SUBARRAY_ENDS_AFTER_ARRAY_END - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- SubCircle - Class in org.hipparchus.geometry.spherical.twod
-
This class represents a sub-hyperplane for
Circle
.
- SubCircle(Hyperplane<Sphere2D>, Region<Sphere1D>) - Constructor for class org.hipparchus.geometry.spherical.twod.SubCircle
-
Simple constructor.
- SubHyperplane<S extends Space> - Interface in org.hipparchus.geometry.partitioning
-
This interface represents the remaining parts of an hyperplane after
other parts have been chopped off.
- SubHyperplane.SplitSubHyperplane<U extends Space> - Class in org.hipparchus.geometry.partitioning
-
Class holding the results of the
split
method.
- SubLimitAngle - Class in org.hipparchus.geometry.spherical.oned
-
This class represents sub-hyperplane for
LimitAngle
.
- SubLimitAngle(Hyperplane<Sphere1D>, Region<Sphere1D>) - Constructor for class org.hipparchus.geometry.spherical.oned.SubLimitAngle
-
Simple constructor.
- SubLine - Class in org.hipparchus.geometry.euclidean.threed
-
This class represents a subset of a
Line
.
- SubLine - Class in org.hipparchus.geometry.euclidean.twod
-
This class represents a sub-hyperplane for
Line
.
- SubLine(Line, IntervalsSet) - Constructor for class org.hipparchus.geometry.euclidean.threed.SubLine
-
Simple constructor.
- SubLine(Segment) - Constructor for class org.hipparchus.geometry.euclidean.threed.SubLine
-
Create a sub-line from a segment.
- SubLine(Vector3D, Vector3D, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.SubLine
-
Create a sub-line from two endpoints.
- SubLine(Segment) - Constructor for class org.hipparchus.geometry.euclidean.twod.SubLine
-
Create a sub-line from a segment.
- SubLine(Vector2D, Vector2D, double) - Constructor for class org.hipparchus.geometry.euclidean.twod.SubLine
-
Create a sub-line from two endpoints.
- SubLine(Hyperplane<Euclidean2D>, Region<Euclidean1D>) - Constructor for class org.hipparchus.geometry.euclidean.twod.SubLine
-
Simple constructor.
- SubOrientedPoint - Class in org.hipparchus.geometry.euclidean.oned
-
- SubOrientedPoint(Hyperplane<Euclidean1D>, Region<Euclidean1D>) - Constructor for class org.hipparchus.geometry.euclidean.oned.SubOrientedPoint
-
Simple constructor.
- SubPlane - Class in org.hipparchus.geometry.euclidean.threed
-
This class represents a sub-hyperplane for
Plane
.
- SubPlane(Hyperplane<Euclidean3D>, Region<Euclidean2D>) - Constructor for class org.hipparchus.geometry.euclidean.threed.SubPlane
-
Simple constructor.
- substituteMostRecentElement(double) - Method in class org.hipparchus.util.ResizableDoubleArray
-
Substitutes value
for the most recently added value.
- subtract(double) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.complex.Complex
-
Returns a Complex
whose value is
(this - subtrahend)
.
- subtract(double) - Method in class org.hipparchus.dfp.Dfp
-
'-' operator.
- subtract(double) - Method in interface org.hipparchus.RealFieldElement
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.util.Decimal64
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.util.FieldTuple
-
'-' operator.
- subtract(double) - Method in class org.hipparchus.util.Tuple
-
'-' operator.
- subtract(double[], int, double[], int, double[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform subtraction of two derivative structures.
- subtract(double, FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Subtract a scaled vector from the instance.
- subtract(double, Vector<S>) - Method in interface org.hipparchus.geometry.Vector
-
Subtract a scaled vector from the instance.
- subtract(int) - Method in class org.hipparchus.fraction.BigFraction
-
Subtracts the value of an integer
from the value of this
BigFraction
, returning the result in reduced form.
- subtract(int) - Method in class org.hipparchus.fraction.Fraction
-
Subtract an integer from the fraction.
- subtract(long) - Method in class org.hipparchus.fraction.BigFraction
-
Subtracts the value of a long
from the value of this
BigFraction
, returning the result in reduced form.
- subtract(BigInteger) - Method in class org.hipparchus.fraction.BigFraction
-
Subtracts the value of an
BigInteger
from the value of this
BigFraction
, returning the result in reduced form.
- subtract(DerivativeStructure) - Method in class org.hipparchus.analysis.differentiation.DerivativeStructure
-
Compute this - a.
- subtract(FieldDerivativeStructure<T>) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
Compute this - a.
- subtract(SparseGradient) - Method in class org.hipparchus.analysis.differentiation.SparseGradient
-
Compute this - a.
- subtract(PolynomialFunction) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Subtract a polynomial from the instance.
- subtract(Complex) - Method in class org.hipparchus.complex.Complex
-
Returns a Complex
whose value is
(this - subtrahend)
.
- subtract(Quaternion) - Method in class org.hipparchus.complex.Quaternion
-
Subtracts a quaternion from the instance.
- subtract(Quaternion, Quaternion) - Static method in class org.hipparchus.complex.Quaternion
-
Subtracts two quaternions.
- subtract(Dfp) - Method in class org.hipparchus.dfp.Dfp
-
Subtract x from this.
- subtract(BigFraction) - Method in class org.hipparchus.fraction.BigFraction
-
Subtracts the value of another fraction from the value of this one,
returning the result in reduced form.
- subtract(Fraction) - Method in class org.hipparchus.fraction.Fraction
-
Subtracts the value of another fraction from the value of this one,
returning the result in reduced form.
- subtract(FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Subtract a vector from the instance.
- subtract(Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Subtract a vector from the instance.
- subtract(Vector<Euclidean1D>) - Method in class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Subtract a vector from the instance.
- subtract(Vector<Euclidean3D>) - Method in class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Subtract a vector from the instance.
- subtract(Vector<Euclidean2D>) - Method in class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Subtract a vector from the instance.
- subtract(Vector<S>) - Method in interface org.hipparchus.geometry.Vector
-
Subtract a vector from the instance.
- subtract(Array2DRowFieldMatrix<T>) - Method in class org.hipparchus.linear.Array2DRowFieldMatrix
-
Subtract m
from this matrix.
- subtract(Array2DRowRealMatrix) - Method in class org.hipparchus.linear.Array2DRowRealMatrix
-
Returns this
minus m
.
- subtract(ArrayFieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute this
minus v
.
- subtract(BlockFieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Compute this - m
.
- subtract(BlockRealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Subtract m
from this matrix.
- subtract(DiagonalMatrix) - Method in class org.hipparchus.linear.DiagonalMatrix
-
Returns this
minus m
.
- subtract(FieldMatrix<T>) - Method in class org.hipparchus.linear.AbstractFieldMatrix
-
Subtract m
from this matrix.
- subtract(FieldMatrix<T>) - Method in class org.hipparchus.linear.BlockFieldMatrix
-
Subtract m
from this matrix.
- subtract(FieldMatrix<T>) - Method in interface org.hipparchus.linear.FieldMatrix
-
Subtract m
from this matrix.
- subtract(FieldVector<T>) - Method in class org.hipparchus.linear.ArrayFieldVector
-
Compute this
minus v
.
- subtract(FieldVector<T>) - Method in interface org.hipparchus.linear.FieldVector
-
Compute this
minus v
.
- subtract(FieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Compute this
minus v
.
- subtract(OpenMapRealMatrix) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Subtract m
from this matrix.
- subtract(OpenMapRealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Optimized method to subtract OpenMapRealVectors.
- subtract(RealMatrix) - Method in class org.hipparchus.linear.AbstractRealMatrix
-
Returns this
minus m
.
- subtract(RealMatrix) - Method in class org.hipparchus.linear.BlockRealMatrix
-
Returns this
minus m
.
- subtract(RealMatrix) - Method in class org.hipparchus.linear.OpenMapRealMatrix
-
Returns this
minus m
.
- subtract(RealMatrix) - Method in interface org.hipparchus.linear.RealMatrix
-
Returns this
minus m
.
- subtract(RealVector) - Method in class org.hipparchus.linear.ArrayRealVector
-
Subtract v
from this vector.
- subtract(RealVector) - Method in class org.hipparchus.linear.OpenMapRealVector
-
Subtract v
from this vector.
- subtract(RealVector) - Method in class org.hipparchus.linear.RealVector
-
Subtract v
from this vector.
- subtract(SparseFieldVector<T>) - Method in class org.hipparchus.linear.SparseFieldVector
-
Optimized method to compute this
minus v
.
- subtract(BigReal) - Method in class org.hipparchus.util.BigReal
-
Compute this - a.
- subtract(Decimal64) - Method in class org.hipparchus.util.Decimal64
-
Compute this - a.
- subtract(FieldTuple<T>) - Method in class org.hipparchus.util.FieldTuple
-
Compute this - a.
- subtract(Tuple) - Method in class org.hipparchus.util.Tuple
-
Compute this - a.
- subtract(T) - Method in class org.hipparchus.analysis.differentiation.FieldDerivativeStructure
-
'-' operator.
- subtract(T) - Method in interface org.hipparchus.FieldElement
-
Compute this - a.
- subtract(T[], int, T[], int, T[], int) - Method in class org.hipparchus.analysis.differentiation.DSCompiler
-
Perform subtraction of two derivative structures.
- subtract(T, FieldVector3D<T>) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Subtract a scaled vector from the instance.
- subtract(T, Vector3D) - Method in class org.hipparchus.geometry.euclidean.threed.FieldVector3D
-
Subtract a scaled vector from the instance.
- Subtract - Class in org.hipparchus.analysis.function
-
Subtract the second operand from the first.
- Subtract() - Constructor for class org.hipparchus.analysis.function.Subtract
-
- subtractExact(int, int) - Static method in class org.hipparchus.util.FastMath
-
Subtract two numbers, detecting overflows.
- subtractExact(long, long) - Static method in class org.hipparchus.util.FastMath
-
Subtract two numbers, detecting overflows.
- sum(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the sum of the values in the input array, or
Double.NaN
if the array is empty.
- sum(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the sum of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray is empty.
- Sum - Class in org.hipparchus.stat.descriptive.summary
-
Returns the sum of the available values.
- Sum() - Constructor for class org.hipparchus.stat.descriptive.summary.Sum
-
Create a Sum instance.
- Sum(Sum) - Constructor for class org.hipparchus.stat.descriptive.summary.Sum
-
Copy constructor, creates a new Sum
identical
to the original
.
- sumDifference(double[], double[]) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the sum of the (signed) differences between corresponding elements of the
input arrays -- i.e., sum(sample1[i] - sample2[i]).
- sumLog(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the sum of the natural logs of the entries in the input array, or
Double.NaN
if the array is empty.
- sumLog(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the sum of the natural logs of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray is empty.
- SumOfClusterVariances<T extends Clusterable> - Class in org.hipparchus.clustering.evaluation
-
Computes the sum of intra-cluster distance variances according to the formula:
\] score = \sum\limits_{i=1}^n \sigma_i^2 \]
where n is the number of clusters and \( \sigma_i^2 \) is the variance of
intra-cluster distances of cluster \( c_i \).
- SumOfClusterVariances(DistanceMeasure) - Constructor for class org.hipparchus.clustering.evaluation.SumOfClusterVariances
-
- sumOfLogs(boolean) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
-
Sets the computeSumOfLogs setting of the factory
- SumOfLogs - Class in org.hipparchus.stat.descriptive.summary
-
Returns the sum of the natural logs for this collection of values.
- SumOfLogs() - Constructor for class org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Create a SumOfLogs instance.
- SumOfLogs(SumOfLogs) - Constructor for class org.hipparchus.stat.descriptive.summary.SumOfLogs
-
Copy constructor, creates a new SumOfLogs
identical
to the original
.
- sumOfSquares(boolean) - Method in class org.hipparchus.stat.descriptive.StreamingStatistics.StreamingStatisticsBuilder
-
Sets the computeSumOfSquares setting of the factory.
- SumOfSquares - Class in org.hipparchus.stat.descriptive.summary
-
Returns the sum of the squares of the available values.
- SumOfSquares() - Constructor for class org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Create a SumOfSquares instance.
- SumOfSquares(SumOfSquares) - Constructor for class org.hipparchus.stat.descriptive.summary.SumOfSquares
-
Copy constructor, creates a new SumOfSquares
identical
to the original
.
- sumSq(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the sum of the squares of the entries in the input array, or
Double.NaN
if the array is empty.
- sumSq(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the sum of the squares of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray
is empty.
- SupportBallGenerator<S extends Space,P extends Point<S>> - Interface in org.hipparchus.geometry.enclosing
-
Interface for generating balls based on support points.
- SVD - org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer.Decomposition
-
Deprecated.
- SymmetricGaussIntegrator - Class in org.hipparchus.analysis.integration.gauss
-
This class's implements
integrate
method assuming that the integral is symmetric about 0.
- SymmetricGaussIntegrator(double[], double[]) - Constructor for class org.hipparchus.analysis.integration.gauss.SymmetricGaussIntegrator
-
Creates an integrator from the given points
and weights
.
- SymmetricGaussIntegrator(Pair<double[], double[]>) - Constructor for class org.hipparchus.analysis.integration.gauss.SymmetricGaussIntegrator
-
Creates an integrator from the given pair of points (first element of
the pair) and weights (second element of the pair.
- SymmLQ - Class in org.hipparchus.linear
-
- SymmLQ(int, double, boolean) - Constructor for class org.hipparchus.linear.SymmLQ
-
- SymmLQ(IterationManager, double, boolean) - Constructor for class org.hipparchus.linear.SymmLQ
-
- SynchronizedRandomGenerator - Class in org.hipparchus.random
-
Any
RandomGenerator
implementation can be thread-safe if it
is used through an instance of this class.
- SynchronizedRandomGenerator(RandomGenerator) - Constructor for class org.hipparchus.random.SynchronizedRandomGenerator
-
Creates a synchronized wrapper for the given RandomGenerator
instance.
- v - Variable in class org.hipparchus.random.AbstractWell
-
Bytes pool.
- validate(RealVector) - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.ParameterValidator
-
Validates the set of parameters.
- validateCovarianceData(double[][], double[][]) - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Validates that the x data and covariance matrix have the same
number of rows and that the covariance matrix is square.
- validateSampleData(double[][], double[]) - Method in class org.hipparchus.stat.regression.AbstractMultipleLinearRegression
-
Validates sample data.
- value() - Method in class org.hipparchus.util.OpenIntToDoubleHashMap.Iterator
-
Get the value of current entry.
- value() - Method in class org.hipparchus.util.OpenIntToFieldHashMap.Iterator
-
Get the value of current entry.
- value(double) - Method in class org.hipparchus.analysis.function.Abs
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Acos
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Acosh
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Asin
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Asinh
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Atan
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Atanh
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Cbrt
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Ceil
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Constant
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Cos
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Cosh
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Exp
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Expm1
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Floor
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Gaussian
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.HarmonicOscillator
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Identity
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Inverse
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Log
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Log10
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Log1p
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Logistic
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Logit
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Minus
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Power
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Rint
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Sigmoid
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Signum
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Sin
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Sinc
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Sinh
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Sqrt
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.StepFunction
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Tan
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Tanh
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.function.Ulp
-
Compute the value of the function.
- value(double) - Method in class org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Interpolate value at a specified abscissa.
- value(double) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Compute the value of the function for the given argument.
- value(double) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Calculate the function value at the given point.
- value(double) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Calculate the function value at the given point.
- value(double) - Method in class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Compute the value for the function.
- value(double) - Method in interface org.hipparchus.analysis.UnivariateFunction
-
Compute the value of the function.
- value(double) - Method in interface org.hipparchus.analysis.UnivariateMatrixFunction
-
Compute the value for the function.
- value(double) - Method in interface org.hipparchus.analysis.UnivariateVectorFunction
-
Compute the value for the function.
- value(double) - Method in class org.hipparchus.special.BesselJ
-
Returns the value of the constructed Bessel function of the first kind,
for the passed argument.
- value(double[]) - Method in class org.hipparchus.analysis.differentiation.GradientFunction
-
Compute the value for the function at the given point.
- value(double[]) - Method in class org.hipparchus.analysis.differentiation.JacobianFunction
-
Compute the value for the function at the given point.
- value(double[]) - Method in interface org.hipparchus.analysis.MultivariateFunction
-
Compute the value for the function at the given point.
- value(double[]) - Method in interface org.hipparchus.analysis.MultivariateMatrixFunction
-
Compute the value for the function at the given point.
- value(double[]) - Method in interface org.hipparchus.analysis.MultivariateVectorFunction
-
Compute the value for the function at the given point.
- value(double[]) - Method in class org.hipparchus.optim.linear.LinearObjectiveFunction
-
Computes the value of the linear equation at the current point.
- value(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.LeastSquaresConverter
-
Compute the value for the function at the given point.
- value(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.MultivariateFunctionMappingAdapter
-
Compute the underlying function value from an unbounded point.
- value(double[]) - Method in class org.hipparchus.optim.nonlinear.scalar.MultivariateFunctionPenaltyAdapter
-
Computes the underlying function value from an unbounded point.
- value(double[], double[][], double[], double, double) - Method in class org.hipparchus.analysis.interpolation.InterpolatingMicrosphere
-
Estimate the value at the requested location.
- value(double, double) - Method in interface org.hipparchus.analysis.BivariateFunction
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.function.Add
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.function.Atan2
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.function.Divide
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.function.Max
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.function.Min
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.function.Multiply
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.function.Pow
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.function.Subtract
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.interpolation.BicubicInterpolatingFunction
-
Compute the value for the function.
- value(double, double) - Method in class org.hipparchus.analysis.interpolation.PiecewiseBicubicSplineInterpolatingFunction
-
Compute the value for the function.
- value(double, double) - Static method in class org.hipparchus.special.BesselJ
-
Returns the first Bessel function, \(J_{order}(x)\).
- value(double, double...) - Method in class org.hipparchus.analysis.function.Gaussian.Parametric
-
Computes the value of the Gaussian at x
.
- value(double, double...) - Method in class org.hipparchus.analysis.function.HarmonicOscillator.Parametric
-
Computes the value of the harmonic oscillator at x
.
- value(double, double...) - Method in class org.hipparchus.analysis.function.Logistic.Parametric
-
Computes the value of the sigmoid at x
.
- value(double, double...) - Method in class org.hipparchus.analysis.function.Logit.Parametric
-
Computes the value of the logit at x
.
- value(double, double...) - Method in class org.hipparchus.analysis.function.Sigmoid.Parametric
-
Computes the value of the sigmoid at x
.
- value(double, double...) - Method in interface org.hipparchus.analysis.ParametricUnivariateFunction
-
Compute the value of the function.
- value(double, double...) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction.Parametric
-
Compute the value of the function.
- value(double, double, double) - Method in class org.hipparchus.analysis.interpolation.TricubicInterpolatingFunction
-
Compute the value for the function.
- value(double, double, double) - Method in interface org.hipparchus.analysis.TrivariateFunction
-
Compute the value for the function.
- value(int) - Method in class org.hipparchus.util.CombinatoricsUtils.FactorialLog
-
Computes log(n!)
.
- value(DerivativeStructure) - Method in interface org.hipparchus.analysis.differentiation.UnivariateDifferentiableFunction
-
Simple mathematical function.
- value(DerivativeStructure) - Method in interface org.hipparchus.analysis.differentiation.UnivariateDifferentiableMatrixFunction
-
Compute the value for the function.
- value(DerivativeStructure) - Method in interface org.hipparchus.analysis.differentiation.UnivariateDifferentiableVectorFunction
-
Compute the value for the function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Acos
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Acosh
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Asin
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Asinh
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Atan
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Atanh
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Cbrt
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Constant
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Cos
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Cosh
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Exp
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Expm1
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Gaussian
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.HarmonicOscillator
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Identity
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Inverse
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Log
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Log10
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Log1p
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Logistic
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Logit
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Minus
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Power
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Sigmoid
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Sin
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Sinc
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Sinh
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Sqrt
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Tan
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.function.Tanh
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.interpolation.HermiteInterpolator
-
Interpolate value at a specified abscissa.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Simple mathematical function.
- value(DerivativeStructure) - Method in class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Simple mathematical function.
- value(DerivativeStructure[]) - Method in interface org.hipparchus.analysis.differentiation.MultivariateDifferentiableFunction
-
Compute the value for the function at the given point.
- value(DerivativeStructure[]) - Method in interface org.hipparchus.analysis.differentiation.MultivariateDifferentiableVectorFunction
-
Compute the value for the function at the given point.
- value(RealVector) - Method in class org.hipparchus.optim.linear.LinearObjectiveFunction
-
Computes the value of the linear equation at the current point.
- value(RealVector) - Method in interface org.hipparchus.optim.nonlinear.vector.leastsquares.MultivariateJacobianFunction
-
Compute the function value and its Jacobian.
- value(T) - Method in interface org.hipparchus.analysis.FieldUnivariateFunction
-
Compute the value of the function.
- value(T) - Method in interface org.hipparchus.analysis.FieldUnivariateMatrixFunction
-
Compute the value for the function.
- value(T) - Method in interface org.hipparchus.analysis.FieldUnivariateVectorFunction
-
Compute the value for the function.
- value(T) - Method in class org.hipparchus.analysis.interpolation.FieldHermiteInterpolator
-
Interpolate value at a specified abscissa.
- value(T) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunction
-
Compute the value of the function.
- value(T) - Method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Compute the value of the function.
- value(T) - Method in class org.hipparchus.analysis.polynomials.PolynomialSplineFunction
-
Compute the value of the function.
- value(T) - Method in interface org.hipparchus.analysis.RealFieldUnivariateFunction
-
Compute the value of the function.
- value(T) - Method in interface org.hipparchus.analysis.RealFieldUnivariateMatrixFunction
-
Compute the value for the function.
- value(T) - Method in interface org.hipparchus.analysis.RealFieldUnivariateVectorFunction
-
Compute the value for the function.
- ValueAndJacobianFunction - Interface in org.hipparchus.optim.nonlinear.vector.leastsquares
-
A interface for functions that compute a vector of values and can compute their
derivatives (Jacobian).
- valueOf(double) - Static method in class org.hipparchus.complex.Complex
-
Create a complex number given only the real part.
- valueOf(double, double) - Static method in class org.hipparchus.complex.Complex
-
Create a complex number given the real and imaginary parts.
- valueOf(String) - Static method in enum org.hipparchus.analysis.solvers.AllowedSolution
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.analysis.solvers.BaseSecantSolver.Method
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.clustering.LocalizedClusteringFormats
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.exception.LocalizedCoreFormats
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.geometry.euclidean.threed.RotationConvention
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.geometry.partitioning.Region.Location
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.geometry.partitioning.Side
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.migration.ode.events.EventHandler.Action
-
Deprecated.
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.ode.events.Action
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.ode.events.FilterType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.ode.LocalizedODEFormats
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.ode.sampling.StepNormalizerBounds
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.ode.sampling.StepNormalizerMode
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.optim.linear.PivotSelectionRule
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.optim.linear.Relationship
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.optim.LocalizedOptimFormats
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.optim.nonlinear.scalar.GoalType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer.Decomposition
-
Deprecated.
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.stat.descriptive.moment.SemiVariance.Direction
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.stat.inference.AlternativeHypothesis
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.stat.LocalizedStatFormats
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.stat.ranking.NaNStrategy
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.stat.ranking.TiesStrategy
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.transform.DctNormalization
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.transform.DftNormalization
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.transform.DstNormalization
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.transform.LocalizedFFTFormats
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.transform.TransformType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.util.MathArrays.OrderDirection
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.util.MathArrays.Position
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.util.PivotingStrategy
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum org.hipparchus.util.ResizableDoubleArray.ExpansionMode
-
Returns the enum constant of this type with the specified name.
- values() - Static method in enum org.hipparchus.analysis.solvers.AllowedSolution
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.analysis.solvers.BaseSecantSolver.Method
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.clustering.LocalizedClusteringFormats
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.dfp.DfpField.RoundingMode
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.exception.LocalizedCoreFormats
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.geometry.euclidean.threed.RotationConvention
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.geometry.LocalizedGeometryFormats
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.geometry.partitioning.BSPTreeVisitor.Order
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.geometry.partitioning.Region.Location
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.geometry.partitioning.Side
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.migration.ode.events.EventHandler.Action
-
Deprecated.
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.ode.events.Action
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.ode.events.FilterType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.ode.LocalizedODEFormats
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.ode.sampling.StepNormalizerBounds
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.ode.sampling.StepNormalizerMode
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.optim.linear.PivotSelectionRule
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.optim.linear.Relationship
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.optim.LocalizedOptimFormats
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.optim.nonlinear.scalar.GoalType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.optim.nonlinear.scalar.gradient.NonLinearConjugateGradientOptimizer.Formula
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.optim.nonlinear.vector.leastsquares.GaussNewtonOptimizer.Decomposition
-
Deprecated.
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.stat.descriptive.moment.SemiVariance.Direction
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.stat.descriptive.rank.Percentile.EstimationType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.stat.inference.AlternativeHypothesis
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.stat.LocalizedStatFormats
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.stat.ranking.NaNStrategy
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.stat.ranking.TiesStrategy
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.transform.DctNormalization
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.transform.DftNormalization
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.transform.DstNormalization
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.transform.LocalizedFFTFormats
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.transform.TransformType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.util.MathArrays.OrderDirection
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.util.MathArrays.Position
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.util.PivotingStrategy
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum org.hipparchus.util.ResizableDoubleArray.ExpansionMode
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- VALUES_ADDED_BEFORE_CONFIGURING_STATISTIC - org.hipparchus.exception.LocalizedCoreFormats
-
Deprecated.
- VALUES_ADDED_BEFORE_CONFIGURING_STATISTIC - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- valuesIterator() - Method in class org.hipparchus.stat.Frequency
-
Returns an Iterator over the set of values that have been added.
- variable(int, double) - Method in class org.hipparchus.analysis.differentiation.DSFactory
-
- variable(int, double) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
- variable(int, T) - Method in class org.hipparchus.analysis.differentiation.FDSFactory
-
- variance(double...) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the variance of the entries in the input array, or
Double.NaN
if the array is empty.
- variance(double[], double) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the variance of the entries in the input array, using the
precomputed mean value.
- variance(double[], double, int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the variance of the entries in the specified portion of
the input array, using the precomputed mean value.
- variance(double[], int, int) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the variance of the entries in the specified portion of
the input array, or Double.NaN
if the designated subarray
is empty.
- Variance - Class in org.hipparchus.stat.descriptive.moment
-
Computes the variance of the available values.
- Variance() - Constructor for class org.hipparchus.stat.descriptive.moment.Variance
-
Constructs a Variance with default (true) isBiasCorrected
property.
- Variance(boolean) - Constructor for class org.hipparchus.stat.descriptive.moment.Variance
-
Constructs a Variance with the specified isBiasCorrected
property.
- Variance(boolean, SecondMoment) - Constructor for class org.hipparchus.stat.descriptive.moment.Variance
-
Constructs a Variance with the specified isBiasCorrected
property and the supplied external second moment.
- Variance(SecondMoment) - Constructor for class org.hipparchus.stat.descriptive.moment.Variance
-
Constructs a Variance based on an external second moment.
- Variance(Variance) - Constructor for class org.hipparchus.stat.descriptive.moment.Variance
-
Copy constructor, creates a new Variance
identical
to the original
.
- varianceDifference(double[], double[], double) - Static method in class org.hipparchus.stat.StatUtils
-
Returns the variance of the (signed) differences between corresponding elements of the
input arrays -- i.e., var(sample1[i] - sample2[i]).
- VariationalEquation - Class in org.hipparchus.ode
-
This class defines a set of
secondary equations
to
compute the global Jacobian matrices with respect to the initial state
vector and, if any, to some parameters of the primary ODE set.
- VariationalEquation(ExpandableODE, ODEJacobiansProvider) - Constructor for class org.hipparchus.ode.VariationalEquation
-
Build variational equation using analytical local partial derivatives.
- VariationalEquation(ExpandableODE, OrdinaryDifferentialEquation, double[], ParametersController, ParameterConfiguration...) - Constructor for class org.hipparchus.ode.VariationalEquation
-
Build variational equation using finite differences for local
partial derivatives.
- VariationalEquation.MismatchedEquations - Exception in org.hipparchus.ode
-
Special exception for equations mismatch.
- vecAbsoluteTolerance - Variable in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Allowed absolute vectorial error.
- vecAbsoluteTolerance - Variable in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed absolute vectorial error.
- vecRelativeTolerance - Variable in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeFieldIntegrator
-
Allowed relative vectorial error.
- vecRelativeTolerance - Variable in class org.hipparchus.ode.nonstiff.AdaptiveStepsizeIntegrator
-
Allowed relative vectorial error.
- Vector<S extends Space> - Interface in org.hipparchus.geometry
-
This interface represents a generic vector in a vectorial space or a point in an affine space.
- VECTOR - Static variable in class org.hipparchus.linear.ConjugateGradient
-
- VECTOR_LENGTH_MISMATCH - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- VECTOR_LENGTH_MISMATCH - org.hipparchus.migration.LocalizedMigrationFormats
-
Deprecated.
- VECTOR_MUST_HAVE_AT_LEAST_ONE_ELEMENT - org.hipparchus.exception.LocalizedCoreFormats
-
- VECTOR_MUST_HAVE_AT_LEAST_ONE_ELEMENT - org.hipparchus.migration.exception.util.LocalizedFormats
-
Deprecated.
- VECTOR_OPERATOR - org.hipparchus.geometry.euclidean.threed.RotationConvention
-
Constant for rotation that have the semantics of a vector operator.
- Vector1D - Class in org.hipparchus.geometry.euclidean.oned
-
This class represents a 1D vector.
- Vector1D(double) - Constructor for class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Simple constructor.
- Vector1D(double, Vector1D) - Constructor for class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Multiplicative constructor
Build a vector from another one and a scale factor.
- Vector1D(double, Vector1D, double, Vector1D) - Constructor for class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Linear constructor
Build a vector from two other ones and corresponding scale factors.
- Vector1D(double, Vector1D, double, Vector1D, double, Vector1D) - Constructor for class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Linear constructor
Build a vector from three other ones and corresponding scale factors.
- Vector1D(double, Vector1D, double, Vector1D, double, Vector1D, double, Vector1D) - Constructor for class org.hipparchus.geometry.euclidean.oned.Vector1D
-
Linear constructor
Build a vector from four other ones and corresponding scale factors.
- Vector1DFormat - Class in org.hipparchus.geometry.euclidean.oned
-
Formats a 1D vector in components list format "{x}".
- Vector1DFormat() - Constructor for class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Create an instance with default settings.
- Vector1DFormat(String, String) - Constructor for class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Create an instance with custom prefix, suffix and separator.
- Vector1DFormat(String, String, NumberFormat) - Constructor for class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Create an instance with custom prefix, suffix, separator and format
for components.
- Vector1DFormat(NumberFormat) - Constructor for class org.hipparchus.geometry.euclidean.oned.Vector1DFormat
-
Create an instance with a custom number format for components.
- Vector2D - Class in org.hipparchus.geometry.euclidean.twod
-
This class represents a 2D vector.
- Vector2D(double[]) - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Simple constructor.
- Vector2D(double, double) - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Simple constructor.
- Vector2D(double, Vector2D) - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Multiplicative constructor
Build a vector from another one and a scale factor.
- Vector2D(double, Vector2D, double, Vector2D) - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Linear constructor
Build a vector from two other ones and corresponding scale factors.
- Vector2D(double, Vector2D, double, Vector2D, double, Vector2D) - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Linear constructor
Build a vector from three other ones and corresponding scale factors.
- Vector2D(double, Vector2D, double, Vector2D, double, Vector2D, double, Vector2D) - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2D
-
Linear constructor
Build a vector from four other ones and corresponding scale factors.
- Vector2DFormat - Class in org.hipparchus.geometry.euclidean.twod
-
Formats a 2D vector in components list format "{x; y}".
- Vector2DFormat() - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Create an instance with default settings.
- Vector2DFormat(String, String, String) - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Create an instance with custom prefix, suffix and separator.
- Vector2DFormat(String, String, String, NumberFormat) - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Create an instance with custom prefix, suffix, separator and format
for components.
- Vector2DFormat(NumberFormat) - Constructor for class org.hipparchus.geometry.euclidean.twod.Vector2DFormat
-
Create an instance with a custom number format for components.
- Vector3D - Class in org.hipparchus.geometry.euclidean.threed
-
This class implements vectors in a three-dimensional space.
- Vector3D(double[]) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Simple constructor.
- Vector3D(double, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Simple constructor.
- Vector3D(double, double, double) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Simple constructor.
- Vector3D(double, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Multiplicative constructor
Build a vector from another one and a scale factor.
- Vector3D(double, Vector3D, double, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Linear constructor
Build a vector from two other ones and corresponding scale factors.
- Vector3D(double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Linear constructor
Build a vector from three other ones and corresponding scale factors.
- Vector3D(double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3D
-
Linear constructor
Build a vector from four other ones and corresponding scale factors.
- Vector3DFormat - Class in org.hipparchus.geometry.euclidean.threed
-
Formats a 3D vector in components list format "{x; y; z}".
- Vector3DFormat() - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Create an instance with default settings.
- Vector3DFormat(String, String, String) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Create an instance with custom prefix, suffix and separator.
- Vector3DFormat(String, String, String, NumberFormat) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Create an instance with custom prefix, suffix, separator and format
for components.
- Vector3DFormat(NumberFormat) - Constructor for class org.hipparchus.geometry.euclidean.threed.Vector3DFormat
-
Create an instance with a custom number format for components.
- VectorFormat<S extends Space> - Class in org.hipparchus.geometry
-
Formats a vector in components list format "{x; y; ...}".
- VectorFormat() - Constructor for class org.hipparchus.geometry.VectorFormat
-
Create an instance with default settings.
- VectorFormat(String, String, String) - Constructor for class org.hipparchus.geometry.VectorFormat
-
Create an instance with custom prefix, suffix and separator.
- VectorFormat(String, String, String, NumberFormat) - Constructor for class org.hipparchus.geometry.VectorFormat
-
Create an instance with custom prefix, suffix, separator and format
for components.
- VectorFormat(NumberFormat) - Constructor for class org.hipparchus.geometry.VectorFormat
-
Create an instance with a custom number format for components.
- VectorialCovariance - Class in org.hipparchus.stat.descriptive.vector
-
Returns the covariance matrix of the available vectors.
- VectorialCovariance(int, boolean) - Constructor for class org.hipparchus.stat.descriptive.vector.VectorialCovariance
-
Constructs a VectorialCovariance.
- VectorialStorelessStatistic - Class in org.hipparchus.stat.descriptive.vector
-
- VectorialStorelessStatistic(int, StorelessUnivariateStatistic) - Constructor for class org.hipparchus.stat.descriptive.vector.VectorialStorelessStatistic
-
Create a new VectorialStorelessStatistic with the given dimension
and statistic implementation.
- verifyBracketing(double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Check that the endpoints specify an interval and the function takes
opposite signs at the endpoints.
- verifyBracketing(UnivariateFunction, double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Check that the endpoints specify an interval and the end points
bracket a root.
- verifyInputArray(double[], double[]) - Static method in class org.hipparchus.analysis.polynomials.PolynomialFunctionNewtonForm
-
Verifies that the input arrays are valid.
- verifyInterpolationArray(double[], double[], boolean) - Static method in class org.hipparchus.analysis.polynomials.PolynomialFunctionLagrangeForm
-
Check that the interpolation arrays are valid.
- verifyInterval(double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Check that the endpoints specify an interval.
- verifyInterval(double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Check that the endpoints specify an interval.
- verifySequence(double, double, double) - Method in class org.hipparchus.analysis.solvers.BaseAbstractUnivariateSolver
-
Check that lower < initial < upper
.
- verifySequence(double, double, double) - Static method in class org.hipparchus.analysis.solvers.UnivariateSolverUtils
-
Check that lower < initial < upper
.
- verifyValues(double[], double[], int, int) - Static method in class org.hipparchus.util.MathArrays
-
This method is used
to verify that the begin and length parameters designate a subarray of positive length
and the weights are all non-negative, non-NaN, finite, and not all zero.
- verifyValues(double[], double[], int, int, boolean) - Static method in class org.hipparchus.util.MathArrays
-
This method is used
to verify that the begin and length parameters designate a subarray of positive length
and the weights are all non-negative, non-NaN, finite, and not all zero.
- verifyValues(double[], int, int) - Static method in class org.hipparchus.util.MathArrays
-
This method is used
to verify that the input parameters designate a subarray of positive length.
- verifyValues(double[], int, int, boolean) - Static method in class org.hipparchus.util.MathArrays
-
This method is used
to verify that the input parameters designate a subarray of positive length.
- Vertex - Class in org.hipparchus.geometry.spherical.twod
-
Spherical polygons boundary vertex.
- visit(int, double) - Method in interface org.hipparchus.linear.RealVectorChangingVisitor
-
Visit one entry of the vector.
- visit(int, double) - Method in interface org.hipparchus.linear.RealVectorPreservingVisitor
-
Visit one entry of the vector.
- visit(int, int, double) - Method in class org.hipparchus.linear.DefaultRealMatrixChangingVisitor
-
Visit one matrix entry.
- visit(int, int, double) - Method in class org.hipparchus.linear.DefaultRealMatrixPreservingVisitor
-
Visit one matrix entry.
- visit(int, int, double) - Method in interface org.hipparchus.linear.RealMatrixChangingVisitor
-
Visit one matrix entry.
- visit(int, int, double) - Method in interface org.hipparchus.linear.RealMatrixPreservingVisitor
-
Visit one matrix entry.
- visit(int, int, T) - Method in class org.hipparchus.linear.DefaultFieldMatrixChangingVisitor
-
Visit one matrix entry.
- visit(int, int, T) - Method in class org.hipparchus.linear.DefaultFieldMatrixPreservingVisitor
-
Visit one matrix entry.
- visit(int, int, T) - Method in interface org.hipparchus.linear.FieldMatrixChangingVisitor
-
Visit one matrix entry.
- visit(int, int, T) - Method in interface org.hipparchus.linear.FieldMatrixPreservingVisitor
-
Visit one matrix entry.
- visit(int, T) - Method in interface org.hipparchus.linear.FieldVectorChangingVisitor
-
Visit one entry of the vector.
- visit(int, T) - Method in interface org.hipparchus.linear.FieldVectorPreservingVisitor
-
Visit one entry of the vector.
- visit(BSPTreeVisitor<S>) - Method in class org.hipparchus.geometry.partitioning.BSPTree
-
Visit the BSP tree nodes.
- visitInternalNode(BSPTree<S>) - Method in interface org.hipparchus.geometry.partitioning.BSPTreeVisitor
-
Visit a BSP tree node node having a non-null sub-hyperplane.
- visitLeafNode(BSPTree<S>) - Method in interface org.hipparchus.geometry.partitioning.BSPTreeVisitor
-
Visit a leaf BSP tree node node having a null sub-hyperplane.
- visitOrder(BSPTree<S>) - Method in interface org.hipparchus.geometry.partitioning.BSPTreeVisitor
-
Determine the visit order for this node.